Benzene phasing through PBC

When I visualise my molecule trajectory, the benzene molecule seems to split across the pbc.
WIll this effect my calculation of the diffusivity using MDAnalysis?

Thank you in advance.

Could this be solved by perhaps defining the COM of benzene?

This is a problem of PBC representation, it is not really physically happening in the box. You can fix it by making molecules whole during the trajectory (gmx trjconv -pbc mol). I think MDAnalysis can handle the periodicity of systems but you should double check, eventually just preprocess the trajectory with GROMACS. You can calculate the diffusivity with GROMACS as well, if needed

What I am trying to do is get a diffusion coefficient which correspons roughly to the experimental results.
I am using charmm and tip3p. I minimise, equilibrate and then do the production run. Then I convert trajectories using the -pbc nojump flag (as per MDAnalysis documentation). Finally, I calculated the diffusion coefficient using this code:

import MDAnalysis as mda
import MDAnalysis.analysis.msd as msd
import matplotlib.pyplot as plt
from scipy.stats import linregress
import numpy as np

Diffusion_Coefficient = ""

def Diffusion_Error(tpr, xtc, selection):
    global msd

    u = mda.Universe(str(tpr), str(xtc))
    MSD = msd.EinsteinMSD(u, str(selection), msd_type='xyz', fft=True)
    MSD.run()

    msd =  MSD.results.timeseries

    nframes = MSD.n_frames
    
    timestep = 10
    lagtimes = np.arange(nframes)*timestep
	
    start_time = 0
    end_time = 400   

    start_index = int(start_time/timestep)
    end_index = int(end_time/timestep)

    linear_model = linregress(lagtimes[start_index:end_index],
      	                               		 msd[start_index:end_index])

    slope = linear_model.slope            
    Diffusion_Coefficient = ((slope * 1/(2*MSD.dim_fac) ))

    print(Diffusion_Coefficient)
    
a = input("tpr file ")
b = input("xtc file ")
c = input("selection ")
Diffusion_Error(a,b,c)

But the diffusion coefficients differ from experimental results. Furthermore, when I change the box size, the values are different!!!

What am I doing wrong?

Thank you in advance. Any help is much appreciated.