HAWK: Higgs Attached to WeaK bosons =============================================================================== HAWK, Version 2.0.1, released on January 20, 2015 HAWK can be downloaded from http://omnibus.uni-freiburg.de/~sd565/programs/hawk/hawk.html ------------------------------------------------------------------------------- HAWK has been tested under Operating Systems: Scientific Linux 5.7, Scientific Linux 6.4 Debian 7.1 64-bit Ubuntu 12.04.3 LTS 32-bit MAC OS X Version 10.6.8, 64 bit Compilers: GNU Fortran (GCC) 4.1.2, 4.4.7, 4.6.3, 4.7.2 pgf95 10.1-0 Intel Fortran Compiler 11.1, 13.1 Openmpi 1.6.4 Language: Fortran 77/95 ------------------------------------------------------------------------------- Summary of changes in HAWK, Version 2.0.1: January 20, 2015: * version 2.0.1 is made compatible with LHAPDF-6.1.5, no other changes ------------------------------------------------------------------------------- AUTHORS: Ansgar Denner University of Wurzburg, Germany (denner@physik.uni-wuerzburg.de) Stefan Dittmaier University of Freiburg, Germany (stefan.dittmaier@physik.uni-freiburg.de) Stefan Kallweit University of Zurich, Switzerland (kallweit@physik.uzh.ch) Alexander Muck RWTH Aachen, Germany (mueck@physik.rwth-aachen.de) ACKNOWLEDGEMENTS: We thank Mariano Ciccolini for performing an independent calculation for vector-boson fusion to verify the correctness of parts of the code. BRIEF DESCRIPTION HAWK is a Monte Carlo integrator for VBFH: pp/ppbar -> H + 2jets, WH/ZH: pp/ppbar -> HW(->ln), HZ(->ll/nn) It includes * NLO QCD and electroweak (EW) corrections * all weak-boson fusion and quark-antiquark annihilation diagrams for VBFH * all interferences at LO and NLO * contributions from incoming photons * leading heavy-Higgs-boson effects at two-loop order (only VBFH) * contributions of b-quark pdfs at LO * an interface to LHApdf * decay of the Higgs boson into a pair of gauge singlets (only VBFH) * options for using an off-shell Higgs propagator * pp and p pbar collisions * effects of anomalous HZZ/HWW couplings The present version does not include * Higgs-boson decays beyond simple two-body kinematics * production of unweighted events * interface to parton showers * contributions from gg initial states PUBLICATIONS: [1] M. Ciccolini, A. Denner, S. Dittmaier, Strong and electroweak corrections to the production of Higgs + 2jets via weak interactions at the LH, Phys. Rev. Lett. 99 (2007) 161803 [arXiv:0707.0381[hep-ph]]; [2] M. Ciccolini, A. Denner, S. Dittmaier, Electroweak and QCD corrections to Higgs production via vector-boson fusion at the LHC, Phys. Rev. D77 (2008) 013002 [arXiv:0710.4749 [hep-ph]]; [3] A. Denner, S. Dittmaier, S. Kallweit, A. Muck Electroweak corrections to Higgs-strahlung off W/Z bosons at the Tevatron and the LHC with HAWK JHEP 07 (2012) 076 [arXiv:1112.5142 [hep-ph]]. INSTALLATION Gunzip and untar HAWK-2.0.1.tar.gz (it will unpack into the directory ./HAWK-2.0) The source files are contained in the HAWK-2.0/src directory. The directory HAWK-2.0/sampleruns contains results of sample runs. The directories HAWK-2.0/bin, HAWK-2.0/obj, and HAWK-2.0/mod are for the executable, object files, and module files, respectively. For usage of up-to-date parton distributions functions (PDFs), an interface to the LHAPDF library is provided. The LHAPDF library is not part of the HAWK distribution. In order to use LHAPDF, a working LHAPDF installation has to be available. The information on the LHAPDF installation can be provided via the LHAPDF executable 'lhapdf-config' which is part of the LHAPDF installation. To make the executable 'lhapdf-config' available, you have the following options: -copy it to the HAWK-2.0 directory -include its directory to the PATH variable of your shell -specify the location of 'lhapdf-config' at the beginning of the 'Makefile' in the variable 'LHAPDF_CONFIG'. Alternatively, the path to the LHAPDF library and, if needed, include files can be set manually in the Makefile via LHAPDF and LHAPDFFFLAGS, respectively. It is also possible to compile HAWK without LHAPDF. For this option, there is the makefile Makefile_no_LHAPDF. However, for usage without LHAPDF, only the tables for three PDF sets (MRST2004QED, CTEQ6L1 and CTEQ6M) are included in the directory HAWK-2.0/PDFs. Edit Makefile or Makefile_no_LHAPDF to change compiler or compiler options. No other libraries are needed. COMPILATION By issuing "make" or "make -f Makefile_no_LHAPDF" in the command line the executable "hawk-2.0" is generated, either with or without linking the LHAPDF library. For removing *.o, *.mod files and the executable issue "make clean". EXECUTION For executions "hawk-2.0" needs an inputfile from the standard input (see however the remarks for parallel execution using mpi below). When using LHApdf, the relevant files for the pdfs should be in the directory PDFsets of LHApdf. When using the included PDF sets, the corresponding table files ("qed6-10gridp.dat" for MRST2004QED or "cteq6m.tbl", "cteq6l1.tbl" for CTEQ6) must be copied from the subdirectory HAWK-2.0/PDFs into the working directory, where hawk-2.0 is executed. The program can be executed using ./hawk-2.0 < inputfile > outputfile. If an output file is specified in the inputfile it will be used. INPUT All input should be delivered via the inputfile. This has to be specified via standard input, otherwise HAWK does not start. Its general format can be seen from the default inputfile "input_default" in the directory HAWK-2.0/sampleruns and the inputfiles of the subdirectories. While the sample input files specify all relevant parameters, it is sufficient to specify those values that differ from the default. Do not forget the "d0" after "double precision" quantities. In the following we present the content of the file "input_default" with additional comments added. The specified values correspond to the default. # global parameters outputfile =' ' ! output to standard output outputfile ='output_default' ! output to file ******************************************************************************* * Name of outputfile * if the variable is blank output is written to standard output ******************************************************************************* selprocess = 0 ! select process: 0 = jet jet H ! 1 = l+ nu H ! 2 = nu~ l- H ! 3 = l+ l- H ! 4 = nu~ nu H ******************************************************************************* * Select the process to be calculated: * selprocess = 0 Hjj p p -> jet jet H (VBFH) * selprocess = 1 Hln p p -> l+ nu H (W+H) * selprocess = 2 Hnl p p -> nu~ l- H (W-H) * selprocess = 3 Hll p p -> l+ l- H (ZH) * selprocess = 4 Hnn p p -> nu~ nu H (ZH) * NOTE: a change of this flag sets all options and cuts to their defaults. * They can be changed thereafter. ******************************************************************************* nevents = 10000000 ! number of events ******************************************************************************* * NOTE: The number of weighted events should be at least 10^7 to guarantee * that the multi-channel integration yields reliable estimates. * For histograms more events should be used. For the published * distributions we used 10^9. ******************************************************************************* energy = 14000d0 ! cms energy in pp/ppbar system in GeV sppbar = 0 ! p p initial state (1 for p pbar) ******************************************************************************* * sppbar=0 p p initial state * sppbar=1 p pbar initial state (p in +z direction) ******************************************************************************* # input parameters gf=0.1166370d-04 ! Fermi constant mz=91.1876d0 ! Z-boson mass gz=2.4952d0 ! Z-boson width mw=80.398d0 ! W-boson mass gw=2.08872d0 ! W-boson width mmu=0.105658367d0 ! muon mass mt=172.5d0 ! top-quark mass mh=126.0d0 ! Higgs mass gh=4.21d-3 ! Higgs width sinthetac=0.225d0 ! sine of the Cabibbo angle ! the CKM matrix is always treated as real and ! block-diagonal, i.e. without mixing between ! 1st/2nd and 3rd generation. ******************************************************************************* * NOTE: The program reads the on-shell masses and widths and translates * them internally to the pole masses and widths. These are then used * in propagators and the complex weak mixing angle and other couplings. * The output provides the pole masses, not the input masses! * * NOTE: The masses of the light fermions appear internally, but the results * are practically independent of the specific values in the alpha_GF * scheme used. Only for bare leptons in the final state their mass * becomes relevant. Here HAWK uses the input value for the muon mass mmu. ******************************************************************************* # recombination and cuts ******************************************************************************* * For VBFH: * recombination of quarks and gluons according to the kt algorithm * of G. C. Blazey et al., hep-ex/0005012 * (variants see under 'ktpower') * * For WH/ZH: * recombination of charged leptons and a bremsstrahlung photon * if deltaR(lep,phot) < dgammaparameter; if this holds for more * than one lepton, the one with the smaller dR is recombined. * The recombined particle is treated as a lepton. * * NOTE: for other recombination schemes the subroutines * "vbfh_recombination" in "vbfh_public.F" or * "whzh_recombination" in "whzh_public.F" must be modified. * If this is required, please contact the authors. ******************************************************************************* ktpower=1 ! kt algorithm (1), anti-kt algorithm (-1), ! Cambridge-Aachen (0) dparameter=0.8d0 ! D parameter of jet algorithm etacut(parton)=5.0d0 ! pseudorapidity cut on partons in jet algorithm dgammaparameter=0.1d0 ! D parameter of lepton-photon recombination ******************************************************************************* * ktpower=1 standard kt algorithm * ktpower=0 Cambridge-Aachen algorithm * ktpower=-1 anti-kt algorithm ******************************************************************************* sbarelep=1 ! leptons are isolated from collinear photons ******************************************************************************* * sbarelep=1 leptons are isolated from collinear photons as * described in 0802.1405 [hep-ph]. * As this option is considered to make sense only in case of * muons, the lepton mass in the splittings is automatically * set to the muon mass. * sbarelep=0 no such isolation is applied, which is the recommended * option to investigate the electron case. ******************************************************************************* scuts=1 ! standard cuts ******************************************************************************* * scuts=0 no cuts (only useful for total cross section) * for VBFH: * scuts=1 standard cuts as defined in references [1,2] given above * (see also T. Figy and D. Zeppenfeld, * Phys. Lett. B 591 (2004) 297 [hep-ph/0403297]) * jets are ordered according to pt of jets * scuts=2 standard cuts as defined in references [1,2]given above * (see also T. Figy and D. Zeppenfeld, * Phys. Lett. B 591 (2004) 297 [hep-ph/0403297]) * jets are ordered according to energy of jets * for WH/ZH: * scuts=1 standard cuts for detected leptons as defined in * reference [3] given above * scuts=2 standard cuts for undetected leptons as defined in * reference [3] given above * NOTE: these options set various cuts to their default values * They can be changed thereafter. * NOTE: for other cut schemes the subroutines * "applycut" or "applyhiggscut" in "public.F" or * "applyjetcut" in "vbfh_public.F" or * "applylepcut" or "applylephiggscut" in "whzh_public.F" * must be modified. * If this is required, please contact the authors. ******************************************************************************* ******************************************************************************* * standard cut parameters * can be set after choosing scuts ******************************************************************************* ******************************************************************************* * standard cuts for VBFH (i.e. selprocess = 0) ******************************************************************************* ptcut(jet1)=20d0 ! lower pt cut on jet 1 (leading jet) ptcut(jet2)=20d0 ! lower pt cut on jet 2 (subleading jet) ycut(jet1)=4.5d0 ! upper |y| cut on jet 1 ycut(jet2)=4.5d0 ! upper |y| cut on jet 2 dycut(jet,jet)=4.0d0 ! lower delta y cut between jets 1 and 2 hemispherecut=1 ! y(jet1)*y(jet2) < 0 ptmax(jet1)=1d30 ! upper pt cut on jet 1 ptmax(jet2)=1d30 ! upper pt cut on jet 2 ptmax(jet3)=1d30 ! upper pt cut on jet 3 ymin(jet1)=0d0 ! lower |y| cut on jet 1 ymin(jet2)=0d0 ! lower |y| cut on jet 2 ymin(jet3)=0d0 ! lower |y| cut on jet 3 ptcut(visible)=0d0 ! lower cut on |pt_jet1+pt_jet2+pt_H| (vector sum) ptmax(visible)=1d30 ! upper cut on |pt_jet1+pt_jet2+pt_H| (vector sum) mlcut(jet,jet)=0d0 ! lower cut on invariant mass of pair of jets 1 and 2 mucut(jet,jet)=1d30 ! upper cut on invariant mass of pair of jets 1 and 2 dphicut(jet1,higgs)=0d0 ! lower cut on azimuth between jet 1 and Higgs dphicut(jet2,higgs)=0d0 ! lower cut on azimuth between jet 2 and Higgs ptcut(higgs)=0d0 ! lower pt cut on Higgs ycut(higgs)=1d10 ! upper |y| cut on Higgs ecut(higgs)=0d0 ! lower energy cut on Higgs mlcut(higgs)=1d-2 ! lower cut on the invariant mass of Higgs mucut(higgs)=1d30 ! upper cut on the invariant mass of Higgs ******************************************************************************* * hemispherecut=0 no hemispherecut * hemispherecut=1 y(jet1)*y(jet2) < 0 required for jets 1 and 2 ******************************************************************************* * to implement a jet veto, ptmax and ymin can be used in combination to define * final states without detectable jets, where a "detectable jet" fulfils * kt(jet) > ptmax(jet) and |y(jet)| < ymin(jet). * The cuts for jet1 apply to all jets, those for jet2 for all but the leading * jet, those for jet3 only to the third jet. * Set ptmax(jet1/2/3)=1d30 and/or ymin(jet1/2/3)=0d0 to switch off these cuts. ******************************************************************************* ******************************************************************************* * standard cuts for WH/ZH (i.e. selprocess = 1, 2, 3, 4) ******************************************************************************* * for scuts=1 ptcut(lep)=20d0 ! lower pt cut on leptons ycut(lep)=2.5d0 ! upper |y| cut on leptons ptmax(lep)=1d10 ! upper pt cut on leptons ymin(lep)=0d0 ! lower |y| cut on leptons * for scuts=2 ptcut(lep)=0d0 ! lower pt cut on leptons ycut(lep)=1d10 ! upper |y| cut on leptons ptmax(lep)=20d0 ! upper pt cut on leptons ymin(lep)=2.5d0 ! lower |y| cut on leptons * for scuts=1 and scuts=2 ptcut(V)=190d0 ! lower pt cut on V ptcut(miss)=25d0 ! lower cut on missing-pT (pT of neutrino(s)) drcut(lep,lep)=0d0 ! lower cut on dR between leptons drcut(jet,lep)=0d0 ! lower cut on dR between lepton and jet mlcut(lep,lep)=0d0 ! lower cut on invariant mass between leptons mucut(lep,lep)=1d10 ! upper cut on invariant mass between leptons ecut(lep)=0d0 ! lower energy cut on leptons ptcut(higgs)=200d0 ! lower pt cut on Higgs ycut(higgs)=1d10 ! upper |y| cut on Higgs ecut(higgs)=0d0 ! lower energy cut on Higgs ******************************************************************************* * in analogy to a jet veto ptmax and ymin are used in combination to define * final states without detectable leptons, where a "detectable lepton" fulfils * ktl > ptmax(lep) and |yl| < ymin(lep). * Set ptmax(lep)=1d10 and/or ymin(lep)=0d0 to switch off this cut. ******************************************************************************* # off-shell Higgs boson, decays and corresponding cuts shtr=0 ! on-shell Higgs boson ******************************************************************************* * shtr=0 on-shell Higgs boson * shtr=1 off-shell Higgs boson * shtr=2 off-shell Higgs boson decaying into a pair of singlets (only for VBFH) * NOTE: for shtr=1 the external Higgs boson is off-shell and the * resonance is treated according to the flag shbw (see below) * for shtr=2 additionally an isotropic Higgs decay into a pair of * scalar singlets is included. This can be used to mimic any two-body * decay, e.g. the decay into photons. * NOTE: for shtr=1 or 2 the width of the Higgs boson has to be given as input * or the width can be calculated internally (see gh and sgh below). * for shtr=2 in addition the branching ratio for the decay into * singlets has to be given * NOTE: for an off-shell Higgs boson the electroweak corrections are * calculated after an on-shell projection of the momenta ******************************************************************************* shbw=1 ! treatment of off-shell Higgs propagator ******************************************************************************* * For an off-shell Higgs boson (shtr=1 or 2) the following prescription * is used for the Higgs resonance: * shbw=0 standard Breit-Wigner with mass mh and (constant) width gh * shbw=1 off-shell propagator according to arXiV:1107.0683, eq. (4.6) * NOTE: for shbw=1, sgh=0 is not allowed ******************************************************************************* sgh=2 ! Higgs-boson width according to complex-mass scheme ******************************************************************************* * sgh=0 use Higgs width as specified in input by gh * sgh=1 gh is set for the input Higgs mass using an interpolation * of the results in arXiv:1101.0593 [hep-ph] * (based on a routine of G. Passarino) * sgh=2 gh is calculated according to the complex-mass scheme * (using cpHTO11.f by G. Passarino) * for sgh=1 or sgh=2 the input value gh is not used ******************************************************************************* gh=0.00421d0 ! Higgs width (for MH=126 GeV) Hbr=1d0 ! branching ratio for Higgs decay into singlets ******************************************************************************* * width of the Higgs boson and branching ratio for the decay into singlets * (for shtr=2). Hbr simply rescales the complete cross section. ******************************************************************************* ptcut(decp)=0d0 ! lower pt cut on Higgs decay products ycut(decp)=1d10 ! upper |y| cut on Higgs decay products higgsbetweenjets=0 ! min(y(jet1),y(jet2))0, sqcdnondiag, sqcdggfus, sqcdgsplit are set to zero, * these contributions are not supported for anomalous * Higgs couplings. ******************************************************************************* # switches for s/t channels, interferences only for VBFH sscha=1 ! s-channel contributions included stcha=1 ! t/u-channel contributions included sch2=1 ! squared diagrams included schint=1 ! interferences included ******************************************************************************* * these switches can be used to switch on or off * contributions connected to s or t channel diagrams, * squared diagrams or interferences * by default all are equal to 1 * NOTE: * to take only squared t-channel (and u-channel) diagrams into account use: * sscha=0 ! s-channel contributions not included * stcha=1 ! t/u-channel contributions included * sch2=1 ! squared diagrams included * schint=0 ! interferences not included * QCD contributions are in addition steered by the switches sqcddiag, * sqcdnondiag, sqcdggfus, and sqcdgsplit ******************************************************************************* * only relevant for VBFH (selprocess = 0), * values are automatically set for WH/ZH (selprocess = 1,2,3,4) ******************************************************************************* # input for anomalous HVV couplings shvv=0 ! anomalous HVV couplings in-/excluded ******************************************************************************* * optional inclusion of anomalous HVV couplings (V=W,Z) * shvv=0 no anomalous HVV couplings * shvv=1 inclusion of anomalous HVV couplings * following the (modified) parametrization of * Hankele, Klamke, Zeppenfeld, Figy, hep-ph/0609075 * -> input on parameters d, db, dt, dtb expected (default=0d0) * added: input parameter rsm rescales SM HVV coupling (default=1d0) * * detailed setting of HVV couplings (called g_... in hep-ph/0609075): * a1hww = mw/sw*rsm = SM HWW coupling * a2hww = 2d0*d /sw/mw = 2*g^(2)_HWW * a3hww = 2d0*dt/sw/mw = 2*gtilde^(2)_HWW * a1haa = 0d0 = HAA like HZZ in SM * a2haa = 4d0*(d *sw2+db *cw2)/2d0/sw/mw = 4*g_HAA * a3haa = 4d0*(dt*sw2+dtb*cw2)/2d0/sw/mw = 4*gtilde_HAA * a1haz = 0d0 = HZA like HZZ in SM * a2haz = -2d0*cw*(d -db )/mw = 2*g^(2)_HZA * ! sign change in a2haz ! * a3haz = -2d0*cw*(dt-dtb)/mw = 2*gtilde^(2)_HZA * ! sign change in a3haz ! * a1hzz = mw/sw/cw2*rsm = SM HZZ coupling * a2hzz = 4d0*(d *cw2+db *sw2)/2d0/sw/mw = 4*g^(2)_HZZ * a3hzz = 4d0*(dt*cw2+dtb*sw2)/2d0/sw/mw = 4*gtilde_HZZ * NOTE: two sign changes due to our conventions of SM couplings * which follow Bohm/Hollik/Spiesberger, Fortsch.Phys.34 (1986) 687 * and Denner, arXiv:0709.1075, Fortsch.Phys.41 (1993) 307 * Feynman rule for HV1(k1_mu)V2(k2_nu): * i*a1hvv*g_{munu} * + i*a2hvv*(-k1.k2*g_{munu}+k1_nu*k2_mu) * + i*a3hvv*eps_{k1k2munu} * shvv=2 direct input for a1hww, ..., a3hzz expected * * NOTE: the anomalous couplings to the neutral gauge bosons are switched * off for small momentum transfer with a formfactor * |s1| |s2| / ( m0**2 + |s1| )/ ( m0**2 + |s2| ) * to avoid IR singularities from anomalous couplings * m0 is fixed to m0=1d0 * NOTE: If shvv>0, sqcdnondiag, sqcdggfus, sqcdgsplit are set to zero, * these contributions are not supported for anomalous * Higgs couplings ******************************************************************************* rsm=1d0 ! rescaling factor of SM HVV coupling d=0.00d0 ! parameter d from hep-ph/0609075 db=0.00d0 ! parameter d_b from hep-ph/0609075 dt=0.00d0 ! parameter tilde d from hep-ph/0609075 dtb=0.00d0 ! parameter tilde d_b from hep-ph/0609075 lambdahvv=-2d0 ! mass scale in formfactor for anomalous couplings ******************************************************************************* * lambdahvv>0 rescaling of HVV couplings by * form factor = lambdahvv^4 / ( lambdahvv^2 + |s1| ) * / ( lambdahvv^2 + |s2| ) * s1,s2 = virtualities of the two intermediate W,Z * lambdahvv<0 form factor = 1 (formal limit lambdahvv -> infinity) ******************************************************************************* # technical parameters for Monte Carlo ranluxseed=0 ! default initialization of random number generator ******************************************************************************* * choosing different positive integers yields different random number seeds ******************************************************************************* # parameters steering the output lnoutmc=1 ! standard output of montecarlo ******************************************************************************* * lnoutmc=1 standard output of montecarlo * lnoutmc=3 intermediate output of montecarlo * lnoutmc=5 full output of montecarlo ******************************************************************************* shisto=1 ! histograms for distributions are produced ******************************************************************************* * shisto=1 histograms are produced * shisto=0 no histograms are produced * * NOTE: by default the following numbers of histograms are included * Hjj: 10 + 2 for off-shell Higgs * Hln: 11 + 2 for off-shell Higgs * Hnl: 11 + 2 for off-shell Higgs * Hll: 12 + 2 for off-shell Higgs * Hnn: 7 + 2 for off-shell Higgs * additional histograms can be implemented by adapting the * subroutines "settings_Hjj" in "vbfh_public.f" or * the subroutines "settings_Hll", "settings_Hlv", "settings_Hvl", or * "settings_Hvv" in "whzh_public.f" ******************************************************************************* OUTPUT By default, all output is written to standard output. An "outputfile" can however be specified in the inputfile. The result for the total cross section can be found under "Summary of results": Born cross section: LO complete cross section: LO + NLO EW + NLO QCD QCD corr. to cross section: NLO QCD = virt. QCD + real QCD + inc. gluon incoming gluon cross section: inc. gluon virt+real QCD cross section: virt. QCD + real QCD virt. QCD cross section: virt. QCD outgoing gluon cross section: real QCD ew corr. to cross section: NLO EW = virt. EW + real EW + inc. photon incoming photon cross section: inc. photon virt+real ew cross section: virt. EW + real EW virt. ew cross section: virt. EW outgoing photon cross section: real EW For "shisto=1", the program produces a set of histograms: ******************************************************************************* * selprocess = 0 Hjj p p -> jet jet H (VBFH) ******************************************************************************* dat.pth distribution in transverse momentum of Higgs dat.yh distribution in rapidity of Higgs dat.etah distribution in pseudorapidity of Higgs distributions of jets: dat.ptjmax1pt distribution in transverse momentum of leading jet dat.ptjmax2pt distribution in transverse momentum of subleading jet dat.yjmax1pt distribution in rapidity of leading jet dat.yjmax2pt distribution in rapidity of subleading jet dat.dyjjmaxpt distribution in rapidity difference of jets dat.dphijjmaxpt distribution in azimuthal angle difference of leading jets dat.mjjmaxpt distribution in invariant mass of leading jets for shtr>0 in addition: dat.mh distribution in invariant mass of off-shell Higgs boson dat.mhwide distribution in invariant mass of off-shell Higgs boson ******************************************************************************* * selprocess = 1 Hlv p p -> l+ nu H (W+H) ******************************************************************************* dat.pth distribution in transverse momentum of Higgs dat.yh distribution in rapidity of Higgs dat.etah distribution in pseudorapidity of Higgs distributions of W+ boson: dat.ptv distribution in transverse momentum of W+ distributions of leptons: dat.ptlp distribution in transverse momentum of l+ dat.ylp distribution in rapidity of l+ dat.etalp distribution in pseudo-rapidity of l+ dat.ptmiss distribution in transverse momentum of nu (= ptmiss) dat.ymiss distribution in rapidity of nu dat.etamiss distribution in pseudo-rapidity of nu dat.dphilpH distribution in azimuthal angle difference of l+ and Higgs for shtr>0 in addition: dat.mh distribution in invariant mass of off-shell Higgs boson dat.mhwide distribution in invariant mass of off-shell Higgs boson ******************************************************************************* * selprocess = 2 Hvl p p -> l+ nu H (W+H) ******************************************************************************* dat.pth distribution in transverse momentum of Higgs dat.yh distribution in rapidity of Higgs dat.etah distribution in pseudorapidity of Higgs distributions of W- boson: dat.ptv distribution in transverse momentum of W- distributions of leptons: dat.ptlm distribution in transverse momentum of l- dat.ylm distribution in rapidity of l- dat.etalm distribution in pseudo-rapidity of l- dat.ptmiss distribution in transverse momentum of nu~ (= ptmiss) dat.ymiss distribution in rapidity of nu~ dat.etamiss distribution in pseudo-rapidity of nu~ dat.dphilmH distribution in azimuthal angle difference of l- and Higgs for shtr>0 in addition: dat.mh distribution in invariant mass of off-shell Higgs boson dat.mhwide distribution in invariant mass of off-shell Higgs boson ******************************************************************************* * selprocess = 3 Hll p p -> l+ l- H (ZH) ******************************************************************************* dat.pth distribution in transverse momentum of Higgs dat.yh distribution in rapidity of Higgs dat.etah distribution in pseudorapidity of Higgs distributions of Z boson: dat.ptv distribution in transverse momentum of Z distributions of leptons: dat.ptlp distribution in transverse momentum of l+ dat.ylp distribution in rapidity of l+ dat.etalp distribution in pseudo-rapidity of l+ dat.ptlm distribution in transverse momentum of l- dat.ylm distribution in rapidity of l- dat.etalm distribution in pseudo-rapidity of l- dat.dphilpH distribution in azimuthal angle difference of l+ and Higgs dat.dphilmH distribution in azimuthal angle difference of l- and Higgs for shtr>0 in addition: dat.mh distribution in invariant mass of off-shell Higgs boson dat.mhwide distribution in invariant mass of off-shell Higgs boson ******************************************************************************* * selprocess = 4 Hvv p p -> nu~ nu H (ZH) ******************************************************************************* dat.pth distribution in transverse momentum of Higgs dat.yh distribution in rapidity of Higgs dat.etah distribution in pseudorapidity of Higgs distributions of Z boson: dat.ptv distribution in transverse momentum of Z distributions of leptons: dat.ptmiss distribution in transverse momentum of (nu + nu~) (= ptmiss) dat.ymiss distribution in rapidity of Z = (nu + nu~) dat.etamiss distribution in pseudo-rapidity of Z = (nu + nu~) for shtr>0 in addition: dat.mh distribution in invariant mass of off-shell Higgs boson dat.mhwide distribution in invariant mass of off-shell Higgs boson ******************************************************************************* These histograms can be adapted, and other histograms can be included by modifying the respective subroutine "settings_Hxx" in "vbfh_public.F" or "whzh_public.F", respectively. For the histograms in Phys.Rev.D77:013002,2008 [arXiv:0710.4749] 10^9 events were used and the histograms rebinned to 20 bins. COMMENTS The virtual electroweak corrections are only calculated for each 100th event, the real electroweak contributions only for each 10th event. 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) The program reads the on-shell masses and widths and translates them internally to the pole masses and widths. These are then used in propagators and the complex weak mixing angle and other couplings. Parallel implementation using the mpi standard: HAWK also supports parallel execution using mpi. To use the parallel version set FC=$(MPIFC) in the makefile where MPIFC should be your MPI Fortran compiler. The parallel version of HAWK has been tested using the Intel Fortran compiler 11.1 and SUN's MPI 8.2. Using HAWK with MPI, the input cannot be provided via standard input (./hawk-2.0 < inputfile) but has to be put into a file with the literal name 'inputfile' in the directory of the hawk-2.0 executable. SAMPLERUNS We provide several sample input files along with the corresponding results. They can be found in the corresponding subdirectories of HAWK-2.0/sampleruns. All sample runs (apart from input_default) use 10^7 events and default input parameters and cuts for the corresponding processes. They typically take between 1 hours (testrun.Hnn) to 12 hours (testrun.Hjj_ofs) (with gfortran on an Intel Nehalem CPU at 3.0 GHz, with the ifort compiler the code typically runs a factor 2-3 faster). The histograms of the sample runs are also provided. * "input_default": This file shows all input parameters with their default values and provides a run with 10^6 events for VBFH, pp -> Hjj, for on-shell Higgs, taking about 1 hour (with the gfortran compiler, or 20 minutes using the ifort compiler). The output can be found in "output_default". The file "input_sample" is equivalent to "input_default", making use of the default settings in HAWK. * "samplerun.Hjj": Subdirectory with a sample run for VBFH, pp -> Hjj, for on-shell Higgs. * "samplerun.Hjj.no_LHAPDF": Subdirectory with a sample run for VBFH, pp -> Hjj, for on-shell Higgs and MRST2004QED PDF. No LHAPDF installation is needed for this sample run. * "samplerun.Hjj.ofs": Subdirectory with a sample run for VBFH, pp -> Hjj, for off-shell Higgs using an off-shell propagator * "samplerun.Hmm": Subdirectory with a sample run for pp -> HZ -> H mu^+ mu^-, for bare muons and on-shell Higgs. * "samplerun.Hnn": Subdirectory with a sample run for pp -> HZ -> H nubar nu, for on-shell Higgs. * "samplerun.Hmn": Subdirectory with a sample run for pp -> HW^+ -> H anti-mu nu, for bare anti-muon and on-shell Higgs. * "samplerun.Hnm": Subdirectory with a sample run for pp -> HW^- -> H anti-nu mu, for bare muon and on-shell Higgs. * "samplerun.Hmn.undet_lepton": Subdirectory with a sample run for pp -> HW^+ -> H anti-mu nu, for on-shell Higgs and undetected bare anti-muon. * "samplerun.Hjj.ac": Subdirectory with a sample run for VBFH, pp -> Hjj, for on-shell Higgs with anomalous VHH couplings. * "samplerun.Hmn.ac": Subdirectory with a sample run for pp -> HW^+ -> H anti-mu nu, for bare anti-muon and on-shell Higgs with anomalous VHH couplings.