PROPHECY4f: a PROPer description of the Higgs dECaY into 4 fermions =============================================================================== Prophecy4f, Version 3.0.2, released on Feb 17, 2022 Prophecy4f can be downloaded from https://prophecy4f.hepforge.org/ ------------------------------------------------------------------------------- Summary of changes in PROPHECY4f 3.0.2: 17/02/22: * compatibility with gfortran 10 (gcc10) fixed Summary of changes in PROPHECY4f 3.0.1: 14/02/22: * unnecessary use of module collier_init eliminated Summary of changes in PROPHECY4f 3.0: 01/12/19: * new model SESM added * new model THDM added * evaluation of one-loop integrals with COLLIER library Summary of changes in PROPHECY4f 2.0.1: 12/03/14: * random number generator RANLUX is added to provide seedable random numbers Summary of changes in PROPHECY4f 2.0: 08/08/11: * production of unweighted events for leptonic final states * optional inclusion of a fourth fermion generation * a bug in the renormalization of the W-boson mass corrected. This leads to an increase of the partial widths of the WW-mediated channels by up to 0.5%. ------------------------------------------------------------------------------- Prophecy4f has been tested under Operating Systems: LINUX, MacOS Compilers: GNU Fortran (GCC) Intel Fortran Compiler Language: Fortran 77 ------------------------------------------------------------------------------- Authors: Ansgar Denner Wuerzburg University, Germany (denner@uni-wuerzburg.de) Stefan Dittmaier Freiburg University, Germany (stefan.dittmaier@physik.uni-freiburg.de) Alexander Mueck RWTH Aachen University, Germany (mueck@physik.rwth-aachen.de) Former authors: Axel Bredenstein Marcus M. Weber BRIEF DESCRIPTION: Prophecy4f is a Monte Carlo integrator for H -> WW/ZZ -> 4fermions. It includes: - all four-fermion final states - NLO QCD and electroweak corrections - all interferences at LO and NLO - corrections beyond NLO from heavy-Higgs effects in the SM - alternatively an Improved Born Approximation (IBA) with leading effects of the corrections in the SM - production of unweighted events for leptonic final states - models: Standard Model (SM), 4th fermion generation (SM4) (w or w/o leading 2-loop improvements), Higgs Singlet Extension of the SM (SESM), Two-Higgs-Doublet Model (THDM). The present version does not (yet) include: - multi-photon final-state radiation - interface to parton showers - anomalous HWW/HZZ couplings or SMEFT dimension-6 operators - production of unweighted events for semi-leptonic and hadronic final states (at present unweighted events only for Born and IBA for these channels) PUBLICATIONS: [1] A. Bredenstein, A. Denner, S. Dittmaier, M.M. Weber, Precise predictions for the Higgs-boson decay H --> W W / Z Z --> 4 leptons, Phys. Rev. D 74 (2006) 013004 [arXiv:hep-ph/0604011]. [2] A. Bredenstein, A. Denner, S. Dittmaier, M.M. Weber, Precision calculations for the Higgs decays H --> Z Z / W W --> 4leptons, Nucl. Phys. Proc. Suppl. 160 (2006) 131 [arXiv:hep-ph/0607060]. [3] A. Bredenstein, A. Denner, S. Dittmaier, M.M. Weber, Radiative corrections to the semileptonic and hadronic Higgs-boson decays H --> W W / Z Z --> 4 fermions, JHEP 0702 (2007) 080 [arXiv:hep-ph/0611234]. [4] L. Altenkamp, S. Dittmaier, H. Rzehak, Renormalization schemes for the Two-Higgs-Doublet Model and applications to h -> WW/ZZ -> 4 fermions, JHEP 1709 (2017) 134 [arXiv:1704.02645]. [5] L. Altenkamp, S. Dittmaier, H. Rzehak, Precision calculations for h -> WW/ZZ -> 4 fermions in the Two-Higgs-Doublet Model with Prophecy4f, JHEP 1803 (2018) 110 [arXiv:1710.07598]. [6] L. Altenkamp, M. Boggia, S. Dittmaier, Precision calculations for h -> WW/ZZ -> 4 fermions in a Singlet Extension of the Standard Model with Prophecy4f, JHEP 1804 (2018) 062 [arXiv:1801.07291]. [7] A. Denner, S. Dittmaier, J.-N. Lang, Renormalization of mixing angles, JHEP 1811 (2018) 104 [arXiv:1808.03466]. INSTALLATION & COMPILATION: Required library: Collier (download from https://collier.hepforge.org/) Follow the documentation of Collier for its installation. Gunzip and untar Prophecy4f-3.0.tar.gz (it will unpack into the directory ./Prophecy4f-3.0/) Issue the following make command from the command line make COLLIERDIR=path FC=compiler where path has to be the path to the Collier library and FC is an optional argument that allows to use the Fortran compiler "compiler" instead of the default one. The executable "Prophecy4f" is generated. For removing *.o files in the directory obj/ issue "make clean". EXECUTION For execution "Prophecy4f" needs an inputfile from the standard input. The program can be executed using "./Prophecy4f < inputfile" All output is written to standard output or to a file if a name is specified in the inputfile. INPUT All input should be delivered via the inputfile. Its general format can be seen from the default inputfile "defaultinput". Only those values that differ from default have to be specified in the input file. Do not forget the "d0" after "double precision" quantities. An inputfile has to be specified via standard input, otherwise Prophecy4f does not start. In the following we present the content of the file "defaultinput" with additional comments added. The specified values correspond to the default. # global parameters outputfile='' ! output is written to standard output ******************************************************************************* * Output will be written to standard output or a given file * if a name is provided here. The plot data will be written * to files named plot.* in directory HISTOGRAMS/. The string 'plot' * is replaced by the file name of the output file if provided. * Unweighted events are written to the directory UNWEIGHTEDEVENTS/ * (*.lhe files) in the same manner. Unweighted events are also binned * into distributions written to the directory HISTUNWEIGHTED/. ******************************************************************************* nevents=10000000 ! nevents: number of weighted events ******************************************************************************* * Number of weighted events, we recommend to use at least 10^7 * events for the integrated partial decay width, for histograms * about 5*10^7 should be used. ******************************************************************************* nunwevents=0 ! nevents: number of weighted events ******************************************************************************* * Number of unweighted events, which are produced in the Les Houches * event file format after the generation of "nevents" weighted events * to find the maximal weights used for unweighting. * Unweighted events have weight 1 or very rarely weight -1. * For nunwevents>0 one has to use: * qsoftcoll=2 (slicing) * qrecomb=0 (no recombination) * For nunwevents>0 the two parameters are set accordingly. ******************************************************************************* model=0 ! model: 0=SM, 1=SESM, 2=THDM, 4=SM4 ******************************************************************************* * The further input that is specific to non-standard models is specified below. ******************************************************************************* contrib=1 ! SM: contrib: 1=best 2=IBA 3=Born ! SM4, SESM and THDM: 1=best 3=Born ******************************************************************************* * Specifies whether to calculate the partial decay width including complete * corrections (NLO corrections as defined by qqcd (see below) * and some higher order effects), the Improved-Born Approximation in the SM * (see Ref. [1] for details) or the leading-order result. ******************************************************************************* qqcd=1 ! qqcd: 0=EW 1=EW+QCD 2=QCD corrections incl. ******************************************************************************* * Specifies whether to use only EW corrections, both EW and QCD * corrections or only QCD corrections. For purely leptonic final * states only EW corrections contribute. ******************************************************************************* qsoftcoll=1 ! qsoftcoll: 1=subtraction, 2=slicing ******************************************************************************* * Soft and collinear singularities can be treated with the subtraction * or the slicing method. For calculations of partial decay widths * subtraction is the preferred option, while for the production of * unweighted events slicing has to be used. ******************************************************************************* channel= e anti-e mu anti-mu ! final state ******************************************************************************* * Final-state fermions (e,mu,nue,num,dq,uq,sq,cq). If more than one channel is * specified, by including several "channel" lines in the input file, * Prophecy4f will calculate the different channels consecutively. * In addition one can choose the special cases: * channel= total * channel= leptonic * channel= semi-leptonic * channel= hadronic * channel= WW * channel= ZZ * channel= interference * Since final-state fermions are treated in the massless limit, * integrated partial widths usually do not differ between different * generations of fermions (For example, the integrated partial decay * width for H -> e anti-e e anti-e is the same as for * H -> mu anti-mu mu anti-mu). Symmetric final states are an exception, * here effects of identical particles are taken into account, * i.e. H -> e anti-e e anti-e is different from H -> e anti-e mu anti-mu. * Moreover, in distributions (or unweighted events) fermion-mass logarithms do * show up if no photon recombination is applied, i.e. fermions of different * generations will in general yield different results. * Third generation fermions cannot be used as input. However, the partial * widths including third generation particles like bottom quarks, tau leptons, * or tau neutrinos do not differ significantly in the massless approximation * from those into fermions of the first and second generation, * i.e. use e.g. H -> mu anti-mu sq anti-sq * to calculate the H -> mu anti-mu bq anti-bq partial width. * Top quarks in the final state are not supported. * The old input format of Version 1.0 is also still supported. ******************************************************************************* qrecomb=1 ! qrecomb: 0=no recomb., 1=photon recomb. invrecomb=5d0 ! recombination condition (for qrecomb=1) ******************************************************************************* * For qrecomb=0 photons and fermions are not recombined. * For qrecomb=1 the photon and the fermion with the smallest invariant mass * are recombined if their invariant mass in GeV is smaller than invrecomb, * i.e. their 4-momenta are added and attributed to the fermion. (Note that we * cannot use a proper jet-algorithm for recombination since the lab frame of * the Higgs decay is not specified). For inclusive partial widths recombination * does not affect the result. * Independent of qrecomb we always recombine the two QCD partons with the * smallest invariant mass in events with gluon emission to form two jets in * semileptonic decays or four jets in hadronic decays. When producing * unweighted events for leptonic final states one has to use qrecomb=0, in * order to create the flexibility to perform the recombination on the event * files after production. ******************************************************************************* qrecombcolle=0 ! 1=recombine electrons and photons inside the ! slicing cone, 0=do not recombine ******************************************************************************* * For qrecombcolle=1 photons and electrons are recombined inside the slicing * cone around electrons (for qsoftcoll=2). In the slicing approximation * these recombined electron-photon pairs are strictly collinear. * The technical slicing cone should always be smaller than the size of the * "physical recombination cone" in which all photons are recombined. * The slicing parameters are: deltaE = 4d-4 and deltaTh = 3d-2. * The option qrecombcolle=1 might be useful to avoid large numbers * of negative unweighted events for electron final states. * For qrecombcolle=0 no electron-photon recombination is performed. ******************************************************************************* mh = 125d0 ! Higgs boson mass in the SM or SM4 alphas = 0.118d0 ! strong coupling constant gf = 1.1663787d-5 ! Fermi constant mz = 91.1876d0 ! on-shell Z-boson mass mw = 80.385d0 ! on-shell W-boson mass gammaz = 2.4952d0 ! on-shell Z-boson width ! (only to calculate pole mass) gammaw = 2.085d0 ! on-shell W-boson width ! (only to calculate pole mass) me = 0.510998928d-3 ! electron mass mmu = 105.6583715d-3 ! muon mass mtau = 1.77682d0 ! tau mass md = 0.100d0 ! d-quark mass mu = 0.100d0 ! u-quark mass ms = 0.100d0 ! s-quark mass mc = 1.51d0 ! c-quark mass mb = 4.92d0 ! b-quark mass mt = 172.5d0 ! t-quark mass ******************************************************************************* * Input parameters: * The values of the fermion masses are needed but the results are * practically independent of the specific values in the alpha_GF scheme * for inclusive quantities. Only if photons and fermions are not recombined, * logarithms of the fermion masses may appear in distributions. * * The values of the on-shell gauge-boson masses and widths as given in the * input are only used to calculate the pole masses of the gauge bosons. * For the actual evaluation of the Higgs decay, the gauge-boson widths * are calculated from the gauge-boson pole masses and the remaining input. * The required complex gauge-boson masses are built from these calculated * widths and the pole masses. Upon using calculated W/Z widths, we can assure * that the effective branching ratios of W and Z bosons add up to 1. * More details are provided below in the "COMMENTS" section. ******************************************************************************* randomseed=-1 ! use random numbers of Prophecy4f version 2.0 ******************************************************************************* * Other positive integer values or zero switch to the usage of RANLUX for * random number generation, where "randomseed" is used as a seed for the * random number generator to obtain statistically independent samples. ******************************************************************************* *============================================================================== * Additional input needed in the SM4: * A 4th fermion generation of massive fermions can be optionally included * upon setting model=4. *============================================================================== qsm4=1 ! 1,2 NLO,NLO+improvements ! only relevant for model=4 ******************************************************************************* * For qsm4=1 or 2 the full mass dependence of the additional closed * fermion loops is taken into account at NLO, comprising the * HWW/HZZ/HZA/HAA vertex corrections as well as all gauge-boson self-energies. * The qsm4=2 option additionally takes into account the leading corrections * ~ Gf^2*mf4^4, alpha_s*Gf*mf4^2 to the HVV vertices, which are taken from * hep-ph/9712330 and hep-ph9602304, respectively. ******************************************************************************* ml4 = 600d0 ! mass of l in 4th fermion generation mn4 = 600d0 ! mass of nu in 4th fermion generation md4 = 600d0 ! mass of d in 4th fermion generation mu4 = 650d0 ! mass of u in 4th fermion generation ******************************************************************************* *============================================================================== * Additional input needed in the SESM (model=1) or THDM (model=2): *============================================================================== hboson=h0 ! Higgs boson in the initial state: ! h0 = light Higgs boson in SESM or THDM ! hh = heavy Higgs boson in SESM or THDM ! irrelevant for SM or SM4 ******************************************************************************* * The SESM/THDM input parameters of MSbar type are defined at the * renormalization scale "mrenbsm1" in the renormalization scheme specified by * "renscheme" and evolved to the renormalization scale "mrenbsm2" by solving * the renormalization group equations numerically. * The parameters at the scale "mrenbsm2" are used in the calculation within * the scheme "renscheme". In particular, this can be used to evaluate the scale * variation with respect to the BSM MSbar parameters (alpha_s is not varied). * To allow for a simple comparison of different renormalization schemes, * in the output the corresponding input parameters in the other ren. schemes * are given as well, as resulting from two different parameter conversion * techniques (see [4-7]). ******************************************************************************* ******************************************************************************* * SESM input: ******************************************************************************* renscheme = 5 ! renormalization scheme ! (see [6] arXiv:1801.07291 and [7] arXiv:1808.03466 ) ! 0 = alpha MSbar (running l12=lambda12)-> MSbar of [6] ! 1 = alpha MSbar a la FJ (running l12) -> FJ of [6] ! 2 = on-shell scheme (running l12) ! 3 = alpha MSbar (running l1=lambda1) -> MSbar(PRTS) of [7] ! 4 = alpha MSbar a la FJ (running l1) -> MSbar(FJTS) of [7] ! 5 = on-shell scheme (running l1) -> OS of [7] ! 6 = BFM-inspired scheme -> based on Eqs. ! (3.41) and (3.64) of [7] ! 7 = BFM-inspired scheme -> BFMS of [7] based ! on Eqs. (3.41) and (3.68) of [7] ! In general, we recommend to use renscheme = 5. mrenbsm1 = 125.1d0 ! start renormalization scale for MSbar parameters ! Here, we use mrenbsm1=mh0 mrenbsm2 = 125.1d0 ! target renormalization scale for MSbar parameters sa = 0.29d0 ! sin(alpha) !ta = 0.303d0 ! tan(alpha), as alternative to define alpha mh0 = 125.1d0 ! mass of the light Higgs boson mhh = 200d0 ! mass of the heavy Higgs boson l12 = 0.07d0 ! coupling lambda12 ******************************************************************************* * The mixing angle alpha varies within -pi/2 < alpha < pi/2. ******************************************************************************* ******************************************************************************* * THDM input: ******************************************************************************* modeltype = 1 ! modeltype: variant of the model as defined in [5] ! 1 = type I: all fermions couple to Higgs doublet phi2 only ! 2 = type II: down-type fermions couple to phi1 ! up-type fermions couple to phi2 ! 3 = lepton specific: quarks couple to phi2, leptons to phi1 ! 4 = flipped: down-type quarks couple to phi1, ! up-type quarks and charged leptons couple to phi2 renscheme = 5 ! renormalization scheme: ! (see [4] arXiv:1704.02645, [5] arXiv:1710.07598, ! [7] arXiv:1808.03466 ) ! 0 = alpha/beta MSbar ! -> MSbar(alpha) of [4,5] = MSbar(PRTS) of [7] ! 1 = alpha/beta MSbar a la FJ ! -> FJ(alpha) of [4,5] = MSbar(FJTS) of [7] ! 2 = lambda3/beta MSbar ! -> MSbar(lambda_3) of [4,5] ! 3 = lambda3/beta MSbar a la FJ ! -> FJ(lambda_3) of [4,5] ! 4 = alpha/beta on-shell (nu2) -> OS2 of [7] ! 5 = alpha/beta on-shell (nu1,nu2) -> OS12 of [7] ! 6 = alpha/beta on-shell (nu1) -> OS1 of [7] ! 7 = BFM-inspired scheme ! -> based on Eqs. (3.41) and (3.74) of [7] ! 8 = BFM-inspired scheme -> BFMS of [7] ! based on Eqs. (3.41) and (3.76) of [7] ! In general, we recommend to use renscheme = 5. mrenbsm1 = 361d0 ! start renormalization scale for MSbar parameters ! Here, we use mrenbsm1=(mh0+mhh+ma0+2mhp)/5 mrenbsm2 = 361d0 ! target renormalization scale for MSbar parameters sa = -0.355d0! sin(alpha) !ta = -0.380d0! tan(alpha), as alternative to define alpha !cba = 0.1d0 ! cos(beta-alpha), as alternative to define alpha !sgnsba = +1 ! sgn[sin(beta-alpha)], required if cba is input tb = 2d0 ! tan(beta) !sb = 0.894d0 ! sin(beta), as alternative to define beta !cb = 0.447d0 ! cos(beta), as alternative to define beta mh0 = 125d0 ! mass of the light CP-even Higgs boson mhh = 300d0 ! mass of the heavy CP-even Higgs boson ma0 = 460d0 ! mass of the CP-odd Higgs boson mhp = 460d0 ! mass of the charged Higgs boson lam5 = -1.9d0 ! coupling lambda5 ******************************************************************************* * The mixing angle beta varies in the range 0 < beta < pi/2, while the * mixing angle alpha varies within -pi/2 < alpha < pi/2. ******************************************************************************* OUTPUT: All output by Prophecy4f is written to standard output or the output file specified in the input. Information about the Collier library is always written to standard output and the Collier output directory. In the output, the input used for the calculation is provided. Along with the full result and its integration error we separately show the lowest-order result and the corresponding contributions due to EW and QCD corrections (if non-zero). HISTOGRAMS: A few default histograms corresponding to the distributions presented in Refs. [1-3] are produced in the directory HISTOGRAMS/. They can be modified in the subroutine "create_histo" in public.F. There, a subroutine called "histogram" is called. Its first two parameters correspond to the range of the histogram, the third parameter to the variable of the distribution, and the number 50 refers to the number of bins. The output format of the histograms is detailed in the corresponding output files. The default histograms are: The invariant-mass distributions for final-state particles 1/2 or 3/4 for different ranges (75-85 GeV, 85-95 GeV, 50-90 GeV, 60-100 GeV). The corresponding files read: outputfile.inv12.5090 outputfile.inv12.7585 outputfile.inv12.60100 outputfile.inv12.8595 outputfile.inv34.5090 outputfile.inv34.7585 outputfile.inv34.60100 outputfile.inv34.8595 The final-state particles 1/2 or 3/4 and the corresponding invariant masses refer to the first two or the last two particles as listed in the output. outputfile.cthv2f2: The cosine of the angle between (k(3)+k(4)) and k(2) in the Higgs rest frame, see e.g. Fig. 12 in hep-ph/0611234 (however, the particle numbering is different there). outputfile.cthv2f3: The cosine of the angle of k(3) with respect to (k(3)+k(4)) in the (k(3)+k(4)) rest frame, see e.g. Fig. 14 in hep-ph/0604011. outputfile.phitrf2f3: Angle between particle 2 and 3 in the transverse plane according to Fig. 15 in hep-ph/0604011. outputfile.cthf1f3: The cosine of the angle between particle 1 and 3 according to Fig. 16 in hep-ph/0604011. outputfile.phi: The distribution of the angle between the decay planes according to Eq. (7.9) in hep-ph/0604011. The ordering of the momenta corresponds to the ordering of the final-state particles in the output file. This is only used for fully leptonic final states. outputfile.cphihad: The distribution of the absolute value of the cosine of the angle between the decay planes (one plane spanned by particles 1 and 2, the second plane spanned by particles 3 and 4), as defined in Eq. (4.2) of hep-ph/0611234. This is only used for semi-leptonic final states. The present version of the program does not provide histograms for hadronic final states and only a smaller set of distributions for semi-leptonic final states. UNWEIGHTED EVENTS: Unweighted events are written to the directory UNWEIGHTEDEVENTS/ in the Les Houches event file format (*.lhe). These files contain also the complete output in their header. As a cross check the unweighted events are binned into distributions written to the directory HISTUNWEIGHTED/. These histograms are equivalent to histograms obtained by binning the events in the *.lhe files accordingly. COMMENTS: Electromagnetic coupling constant: The electromagnetic coupling constant is derived from the Fermi constant. This procedure takes into account some higher-order effects already at tree level. Treatment of gauge-boson resonances: Gauge-boson resonances are treated using the complex-mass scheme. (A. Denner, S. Dittmaier, M. Roth, L.H. Wieders, Nucl.Phys.B724:247-294,2005, hep-ph/0505042) As input, the program expects the on-shell W/Z masses and widths. From these it calculates internally the real parts of the complex pole masses. The imaginary parts of the complex pole masses, i.e. the vector-boson widths are calculated from the pole masses and the other input parameters as described in the next paragraph. These pole masses are then used in propagators and the complex weak mixing angle and other couplings. Decay widths of vector bosons: The decay widths of the W and Z bosons that enter the complex pole masses are calculated from the pole masses and the other input parameters as follows: If only LO order results are requested (i.e. for contrib=3) the LO gauge-boson widths are used. For NLO results and the IBA (contrib=1 or contrib=2) we apply the NLO gauge-boson widths (also for the LO sub-contribution). This ensures that the effective branching fractions for the W- and Z-boson decays in both LO and NLO add up to one. Note that in the Refs. [1-3] we have presented the LO results with NLO gauge-boson widths. At LO, the difference is, of course, only a higher-order effect. Comment on SESM/THDM calculations: Since the NLO W/Z widths are almost identical to the SM NLO widths, the latter are used (with a SM Higgs mass set to the mass of the decaying Higgs boson). Leading-logarithmic final-state radiation: Higher-order effects of collinear photon radiation are not yet supported in this version. Parton shower An interface to a parton shower is not provided yet. In fact, naively using a shower algorithm in combination with the NLO corrections would lead to a double counting of real radiation. Runtime of the program For 10^7 weighted events the program will roughly run 10-90 minutes depending on the final state, hardware, and compilers. The production of 10^6 unweighted events will take about 1-2 days. Total width The total width for H -> 4 fermions are obtained by summing over all possible final states: Gamma(H->4f) = 3*Gamma(nue anti-nue num anti-num) + 3*Gamma(e anti-e mu anti-mu) + 6*Gamma(nue anti-nue mu anti-mu) + 6*Gamma(nue anti-e mu anti-num) + 3*Gamma(nue anti-nue nue anti-nue) + 3*Gamma(e anti-e e anti-e) + 3*Gamma(nue anti-e e anti-nue) + Gamma(uq anti-uq cq anti-cq) + 3*Gamma(dq anti-dq sq anti-sq) + 4*Gamma(uq anti-uq sq anti-sq) + 2*Gamma(uq anti-dq sq anti-cq) + 2*Gamma(uq anti-uq uq anti-uq) + 3*Gamma(dq anti-dq dq anti-dq) + 2*Gamma(uq anti-dq dq anti-uq) + 6*Gamma(nue anti-nue uq anti-uq) + 9*Gamma(nue anti-nue dq anti-dq) + 6*Gamma(uq anti-uq e anti-e) + 9*Gamma(dq anti-dq e anti-e) + 12*Gamma(nue anti-e dq anti-uq). The above three blocks correspond to the leptonic, hadronic, and semi-leptonic width, respectively, which can be obtained via channel=leptonic, channel=hadronic, channel=semi-leptonic. The total width can be obtained via channel=total. The individual channels can also be combined to provide the decays via WW, ZZ and interference as follows: Gamma(H->W*W*->4f) = 9*Gamma(nue anti-nue mu anti-mu) + 12*Gamma(nue anti-e dq anti-uq) + 4*Gamma(uq anti-dq sq anti-cq), Gamma(H->Z*Z*->4f) = 3*Gamma(nue anti-nue num anti-num) + 3*Gamma(e anti-e mu anti-mu) + 9*Gamma(nue anti-nue mu anti-mu) + 3*Gamma(nue anti-nue nue anti-nue) + 3*Gamma(e anti-e e anti-e) + 6*Gamma(nue anti-nue uq anti-uq) + 9*Gamma(nue anti-nue dq anti-dq) + 6*Gamma(uq anti-uq e anti-e) + 9*Gamma(dq anti-dq e anti-e) + Gamma(uq anti-uq cq anti-cq) + 3*Gamma(dq anti-dq sq anti-sq) + 6*Gamma(uq anti-uq sq anti-sq) + 2*Gamma(uq anti-uq uq anti-uq) + 3*Gamma(dq anti-dq dq anti-dq), Gamma(WW/ZZ-interference) = + 3*Gamma(nue anti-e e anti-nue) - 3*Gamma(nue anti-nue mu anti-mu) - 3*Gamma(nue anti-e mu anti-num) + 2*Gamma(uq anti-dq dq anti-uq) - 2*Gamma(uq anti-du ds anti-us) - 2*Gamma(uq anti-dq ds anti-uc). EXAMPLES: Examples for inputfiles and the resulting output are given in the directory example-runs/. It contains the subdirectories example-paper/, example-channels/, example-unweighted/, example-SESM/, and example-THDM/: example-paper/ This directory contains input files for the decay modes H -> ZZ -> e anti-e mu anti-mu, H -> ZZ -> e anti-e e anti-e, H -> WW -> nue anti-e mu anti-num and H -> WW -> nue anti-e e anti-nue in the SM with Higgs masses of 140, 170, and 200 GeV for the input parameters of Ref.[1]. For reference the corresponding output files are provided in "out.*" and the histograms in the directory example-paper/HISTOGRAMS/. The results for the WW-mediated channels differ by up to 0.5% from those given in Table 1 of Ref.[1] due to the bug in the renormalization of the (complex) W-boson mass. The ZZ-mediated channels give slightly different results from those in Refs. [1-3] since the top-mass effects in the Z width calculation are treated in an improved manner in the present version of Prophecy4f. example-channels/ This directory contains input and corresponding output files for all final states in the SM for a Higgs mass of 125 GeV for the default input parameter set. example-unweighted/ This directory contains input and corresponding output files for the production of unweighted events for leptonic final states in the SM, a Higgs mass of 125 GeV and the default input parameter set. example-SESM/ This directory contains input files for the decay mode of the light CP-even Higgs boson h0 -> WW -> num anti-mu e anti-nue of the SESM scenario BHM200 of Refs. [6,7]. example-THDM/ This directory contains input files for the decay mode of the light CP-even Higgs boson h0 -> WW -> num anti-mu e anti-nue of the THDM scenario Aa of Refs. [4,5], which is identical to A1 of Ref. [7]. MPI: PROPHECY4f supports parallel execution using MPI. To use the parallel version, one has to compile the program using the preprocessor flag "-Dmpiuse" and make sure that proper MPI libraries are linked. The program will produce nevents weighted events in total and nunwevents unweighted events per core. The parallel version of Prophecy4f has been tested using Intel's Fortran compiler with Intel's MPI. Large unweighted event samples: In unweighting runs with more than 10^6 unweighted events in a single run it is possible that fewer unweighted events are generated than requested. This is caused by a 32bit integer overflow and can be solved by using 64bit integers everywhere. The default size of all integers can be controlled using the following compiler options for the Fortran compiler: gfortran: -fdefault-integer-8 ifort: -integer-size 64 These options are the default in the supplied makefile.