Page MenuHomeHEPForge

No OneTemporary

Index: branches/color6/share/models/Color6.mdl
===================================================================
--- branches/color6/share/models/Color6.mdl (revision 0)
+++ branches/color6/share/models/Color6.mdl (revision 3984)
@@ -0,0 +1,273 @@
+########################################################################
+# Standard Model with trivial CKM matrix
+model "Color6"
+
+# Independent parameters
+### DO NOT CHANGE THE ORDER OF THESE PARAMETERS
+parameter GF = 1.16639E-5 # Fermi constant
+parameter mZ = 91.1882 # Z-boson mass
+parameter mW = 80.419 # W-boson mass
+parameter mH = 200 # Higgs mass
+parameter mth = 500 # Theta mass
+parameter mxi = 100 # Xi mass
+parameter mpsi = 50 # Psi mass
+parameter alphas = 0.1178 # Strong coupling constant (Z point)
+parameter me = 0.000510997 # electron mass
+parameter mmu = 0.105658389 # muon mass
+parameter mtau = 1.77705 # tau-lepton mass
+parameter ms = 0.095 # s-quark mass
+parameter mc = 1.2 # c-quark mass
+parameter mb = 4.2 # b-quark mass
+parameter mtop = 173.1 # t-quark mass
+parameter wtop = 1.523 # t-quark width
+parameter wZ = 2.443 # Z-boson width
+parameter wW = 2.049 # W-boson width
+parameter wH = 1.419 # Higgs width
+parameter wth = 0 # Theta width
+parameter wxi = 0 # Xi width
+parameter wpsi = 0 # Psi width
+parameter khgaz = 0.000 # anomaly Higgs couplings K factors
+parameter khgaga = 0.000 # anomaly Higgs couplings K factors
+parameter khgg = 0.000 # anomaly Higgs couplings K factors
+parameter xi0 = 0.000 # R_xi parameter for Z-boson
+parameter xipm = 0.000 # R_xi parameter for W-boson
+
+# Dependent parameters
+derived v = 1 / sqrt (sqrt (2.) * GF) # v (Higgs vev)
+derived cw = mW / mZ # cos(theta-W)
+derived sw = sqrt (1-cw**2) # sin(theta-W)
+derived ee = 2 * sw * mW / v # em-coupling (GF scheme)
+derived alpha_em_i = 4 * pi / ee**2 # inverse fine structure const
+
+########################################################################
+# Particle content
+
+# The quarks
+particle D_QUARK 1 parton
+ spin 1/2 charge -1/3 isospin -1/2 color 3
+ name d down
+ anti dbar D "d~"
+ tex_anti "\bar{d}"
+particle U_QUARK 2 parton
+ spin 1/2 charge 2/3 isospin 1/2 color 3
+ name u up
+ anti ubar U "u~"
+ tex_anti "\bar{u}"
+particle S_QUARK 3 like D_QUARK
+ name s strange
+ anti sbar S "s~"
+ tex_anti "\bar{s}"
+ mass ms
+particle C_QUARK 4 like U_QUARK
+ name c charm
+ anti cbar C "c~"
+ tex_anti "\bar{c}"
+ mass mc
+particle B_QUARK 5 like D_QUARK
+ name b bottom
+ anti bbar B "b~"
+ tex_anti "\bar{b}"
+ mass mb
+particle T_QUARK 6 like U_QUARK
+ name t top
+ anti tbar T "t~"
+ tex_anti "\bar{t}"
+ mass mtop width wtop
+
+# The leptons
+particle E_LEPTON 11
+ spin 1/2 charge -1 isospin -1/2
+ name "e-" e1 electron e
+ anti "e+" E1 positron
+ tex_name "e^-"
+ tex_anti "e^+"
+ mass me
+particle E_NEUTRINO 12 left
+ spin 1/2 isospin 1/2
+ name nue n1 "nu_e" ve "e-neutrino"
+ anti nuebar N1 "ve~"
+ tex_name "\nu_e"
+ tex_anti "\bar\nu_e"
+particle MU_LEPTON 13 like E_LEPTON
+ name "mu-" e2 mu muon
+ anti "mu+" E2
+ tex_name "\mu^-"
+ tex_anti "\mu^+"
+ mass mmu
+particle MU_NEUTRINO 14 like E_NEUTRINO
+ name numu "nu_mu" n2 vm "mu-neutrino"
+ anti numubar N2 "vm~"
+ tex_name "\nu_\mu"
+ tex_anti "\bar\nu_\mu"
+particle TAU_LEPTON 15 like E_LEPTON
+ name "tau-" e3 tau "ta-" tauon
+ anti "tau+" E3 "ta+"
+ tex_name "\tau^-"
+ tex_anti "\tau^+"
+ mass mtau
+particle TAU_NEUTRINO 16 like E_NEUTRINO
+ name nutau "nu_tau" n3 vt "tau_neutrino"
+ anti nutaubar N3 "vt~"
+ tex_name "\nu_\tau"
+ tex_anti "\bar\nu_\tau"
+
+# The vector bosons
+particle GLUON 21 parton gauge
+ spin 1 color 8
+ name gl g G gluon
+particle PHOTON 22 gauge
+ spin 1
+ name A gamma photon
+ tex_name "\gamma"
+particle Z_BOSON 23 gauge
+ spin 1
+ name Z
+ mass mZ width wZ
+particle W_BOSON 24 gauge
+ spin 1 charge 1
+ name "W+" Wp
+ anti "W-" Wm
+ tex_name "W^+"
+ tex_anti "W^-"
+ mass mW width wW
+
+# The Higgs
+particle HIGGS 25
+ spin 0
+ name H h Higgs
+ mass mH width wH
+
+# The Crazy Scalars
+particle THETA 40
+ spin 0
+ name th theta
+ anti thc thetac
+ tex_name "\Theta"
+ tex_anti "\bar\Theta"
+ mass mth width wth
+particle XI 41
+ spin 0
+ name xi
+ anti xic
+ tex_name "\Xi"
+ tex_anti "\bar\Xi"
+ mass mxi width wxi
+particle PSI 42
+ spin 0
+ name psi ps
+ tex_name "\Psi"
+ mass mpsi width wpsi
+
+# Hadrons
+particle PROTON 2212
+ spin 1/2 charge 1
+ name p "p+"
+ anti pbar "p-"
+
+particle HADRON_REMNANT 90
+
+particle HADRON_REMNANT_SINGLET 91
+
+particle HADRON_REMNANT_TRIPLET 92
+ color 3
+
+particle HADRON_REMNANT_OCTET 93
+ color 8
+
+########################################################################
+# Vertices of the Standard model
+# In graphs with identical structure the first vertex is kept for phase space
+# therefore, lighter particles come before heavier ones.
+
+# QED
+vertex D d A
+vertex U u A
+vertex S s A
+vertex C c A
+vertex B b A
+vertex T t A
+
+vertex E1 e1 A
+vertex E2 e2 A
+vertex E3 e3 A
+
+# QCD
+vertex G G G
+vertex G G G G
+
+vertex D d G
+vertex U u G
+vertex S s G
+vertex C c G
+vertex B b G
+vertex T t G
+
+# Neutral currents
+vertex D d Z
+vertex U u Z
+vertex S s Z
+vertex C c Z
+vertex B b Z
+vertex T t Z
+
+vertex E1 e1 Z
+vertex E2 e2 Z
+vertex E3 e3 Z
+vertex N1 n1 Z
+vertex N2 n2 Z
+vertex N3 n3 Z
+
+
+# Charged currents
+vertex U d Wp
+vertex C s Wp
+vertex T b Wp
+vertex D u Wm
+vertex S c Wm
+vertex B t Wm
+
+vertex N1 e1 Wp
+vertex N2 e2 Wp
+vertex N3 e3 Wp
+vertex E1 n1 Wm
+vertex E2 n2 Wm
+vertex E3 n3 Wm
+
+# Yukawa
+### keeping only 3rd generation for the moment
+# vertex S s H
+# vertex C c H
+vertex B b H
+vertex T t H
+# vertex E2 e2 H
+vertex E3 e3 H
+
+# Vector-boson self-interactions
+vertex Wp Wm A
+vertex Wp Wm Z
+
+vertex Wp Wm Z Z
+vertex Wp Wp Wm Wm
+vertex Wp Wm Z A
+vertex Wp Wm A A
+
+
+# Higgs - vector boson
+#vertex H Z A
+#vertex H A A
+#vertex H g g
+
+vertex H Wp Wm
+vertex H Z Z
+vertex H H Wp Wm
+vertex H H Z Z
+
+# Higgs self-interactions
+vertex H H H
+vertex H H H H
+
+# Special vertices
+vertex theta xic psi
+vertex thetac xi psi
+
+
Index: branches/color6/src/models/parameters.Color6.f90
===================================================================
--- branches/color6/src/models/parameters.Color6.f90 (revision 0)
+++ branches/color6/src/models/parameters.Color6.f90 (revision 3984)
@@ -0,0 +1,202 @@
+! $Id: parameters.Color6.f90,v 1.4 2006/06/16 13:31:48 kilian Exp $
+!
+! Copyright (C) 1999-2011 by
+! Wolfgang Kilian <kilian@physik.uni-siegen.de>
+! Thorsten Ohl <ohl@physik.uni-wuerzburg.de>
+! Juergen Reuter <juergen.reuter@desy.de>
+! Christian Speckner <christian.speckner@physik.uni-freiburg.de>
+!
+! WHIZARD is free software; you can redistribute it and/or modify it
+! under the terms of the GNU General Public License as published by
+! the Free Software Foundation; either version 2, or (at your option)
+! any later version.
+!
+! WHIZARD is distributed in the hope that it will be useful, but
+! WITHOUT ANY WARRANTY; without even the implied warranty of
+! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+! GNU General Public License for more details.
+!
+! You should have received a copy of the GNU General Public License
+! along with this program; if not, write to the Free Software
+! Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
+!
+!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
+module parameters_color6
+ use kinds
+ use constants
+ use sm_physics !NODEP!
+ implicit none
+ private
+
+ real(default), dimension(42), public :: mass, width
+ real(default), public :: as
+ complex(default), public :: gs, igs
+
+ real(default), public :: e, g, e_em
+ real(default), public :: sinthw, costhw, sin2thw, tanthw
+ real(default), public :: qelep, qeup, qedwn
+ complex(default), public :: qlep, qup, qdwn, gcc, qw, &
+ gzww, gwww, ghww, ghhww, ghzz, ghhzz, &
+ ghbb, ghtt, ghcc, ghtautau, gh3, gh4, ghmm, &
+ iqw, igzww, igwww, gw4, gzzww, gazww, gaaww
+ real(default), public :: vev
+ complex(default), dimension(2), public :: &
+ gncneu, gnclep, gncup, gncdwn
+ real(default), public :: unit
+
+ public :: import_from_whizard, model_update_alpha_s
+
+contains
+
+ subroutine import_from_whizard (par_array)
+ real(default), dimension(31), intent(in) :: par_array
+ type :: parameter_set
+ real(default) :: gf
+ real(default) :: mZ
+ real(default) :: mW
+ real(default) :: mH
+ real(default) :: mth
+ real(default) :: mxi
+ real(default) :: mpsi
+ real(default) :: alphas
+ real(default) :: me
+ real(default) :: mmu
+ real(default) :: mtau
+ real(default) :: ms
+ real(default) :: mc
+ real(default) :: mb
+ real(default) :: mtop
+ real(default) :: wtop
+ real(default) :: wZ
+ real(default) :: wW
+ real(default) :: wH
+ real(default) :: wth
+ real(default) :: wxi
+ real(default) :: wpsi
+ real(default) :: khgaz
+ real(default) :: khgaga
+ real(default) :: khgg
+ real(default) :: xi0
+ real(default) :: xipm
+ real(default) :: v
+ real(default) :: cw
+ real(default) :: sw
+ real(default) :: ee
+ end type parameter_set
+ type(parameter_set) :: par
+ !!! This corresponds to 1/alpha = 137.03598949333
+ real(default), parameter :: &
+ alpha = 1.0_default/137.03598949333_default
+ e_em = sqrt(4.0_default * PI * alpha)
+ par%gf = par_array(1)
+ par%mZ = par_array(2)
+ par%mW = par_array(3)
+ par%mH = par_array(4)
+ par%mth = par_array(5)
+ par%mxi = par_array(6)
+ par%mpsi = par_array(7)
+ par%alphas = par_array(8)
+ par%me = par_array(9)
+ par%mmu = par_array(10)
+ par%mtau = par_array(11)
+ par%ms = par_array(12)
+ par%mc = par_array(13)
+ par%mb = par_array(14)
+ par%mtop = par_array(15)
+ par%wtop = par_array(16)
+ par%wZ = par_array(17)
+ par%wW = par_array(18)
+ par%wH = par_array(19)
+ par%wth = par_array(20)
+ par%wxi = par_array(21)
+ par%wpsi = par_array(22)
+ par%khgaz = par_array(23)
+ par%khgaga = par_array(24)
+ par%khgg = par_array(25)
+ par%xi0 = par_array(26)
+ par%xipm = par_array(27)
+ par%v = par_array(28)
+ par%cw = par_array(29)
+ par%sw = par_array(30)
+ par%ee = par_array(31)
+ mass(1:42) = 0
+ width(1:42) = 0
+ mass(3) = par%ms
+ mass(4) = par%mc
+ mass(5) = par%mb
+ mass(6) = par%mtop
+ width(6) = par%wtop
+ mass(11) = par%me
+ mass(13) = par%mmu
+ mass(15) = par%mtau
+ mass(23) = par%mZ
+ width(23) = par%wZ
+ mass(24) = par%mW
+ width(24) = par%wW
+ mass(25) = par%mH
+ width(25) = par%wH
+ mass(26) = par%xi0 * mass(23)
+ width(26) = 0
+ mass(27) = par%xipm * mass(24)
+ width(27) = 0
+ mass(40) = par%mth
+ width(40) = par%wth
+ mass(41) = par%mxi
+ width(41) = par%wxi
+ mass(42) = par%mpsi
+ width(42) = par%wpsi
+ vev = par%v
+ e = par%ee
+ sinthw = par%sw
+ sin2thw = par%sw**2
+ costhw = par%cw
+ tanthw = sinthw/costhw
+ qelep = - 1
+ qeup = 2.0_default / 3.0_default
+ qedwn = - 1.0_default / 3.0_default
+ g = e / sinthw
+ gcc = - g / 2 / sqrt (2.0_default)
+ gncneu(1) = - g / 2 / costhw * ( + 0.5_default)
+ gnclep(1) = - g / 2 / costhw * ( - 0.5_default - 2 * qelep * sin2thw)
+ gncup(1) = - g / 2 / costhw * ( + 0.5_default - 2 * qeup * sin2thw)
+ gncdwn(1) = - g / 2 / costhw * ( - 0.5_default - 2 * qedwn * sin2thw)
+ gncneu(2) = - g / 2 / costhw * ( + 0.5_default)
+ gnclep(2) = - g / 2 / costhw * ( - 0.5_default)
+ gncup(2) = - g / 2 / costhw * ( + 0.5_default)
+ gncdwn(2) = - g / 2 / costhw * ( - 0.5_default)
+ qlep = - e * qelep
+ qup = - e * qeup
+ qdwn = - e * qedwn
+ qw = e
+ iqw = (0,1)*qw
+ gzww = g * costhw
+ igzww = (0,1)*gzww
+ gwww = g
+ igwww = (0,1)*gwww
+ gw4 = gwww**2
+ gzzww = gzww**2
+ gazww = gzww * qw
+ gaaww = qw**2
+ ghww = mass(24) * g
+ ghhww = g**2 / 2.0_default
+ ghzz = mass(23) * g / costhw
+ ghhzz = g**2 / 2.0_default / costhw**2
+ ghtt = - mass(6) / vev
+ ghbb = - mass(5) / vev
+ ghcc = - mass(4) / vev
+ ghtautau = - mass(15) / vev
+ ghmm = - mass(13) / vev
+ gh3 = - 3 * mass(25)**2 / vev
+ gh4 = - 3 * mass(25)**2 / vev**2
+ !!! Color flow basis, divide by sqrt(2)
+ gs = sqrt(2.0_default*PI*par%alphas)
+ igs = cmplx (0.0_default, 1.0_default, kind=default) * gs
+ unit = 1.0_default
+ end subroutine import_from_whizard
+
+ subroutine model_update_alpha_s (alpha_s)
+ real(default), intent(in) :: alpha_s
+ gs = sqrt(2.0_default*PI*alpha_s)
+ igs = cmplx (0.0_default, 1.0_default, kind=default) * gs
+ end subroutine model_update_alpha_s
+end module parameters_color6
Index: branches/color6/src/omega/src/omega_Color6.ml
===================================================================
--- branches/color6/src/omega/src/omega_Color6.ml (revision 0)
+++ branches/color6/src/omega/src/omega_Color6.ml (revision 3984)
@@ -0,0 +1,33 @@
+(* $Id: omega_Template.ml 1340 2009-12-02 23:45:04Z ohl $
+
+ Copyright (C) 1999-2009 by
+
+ Wolfgang Kilian <kilian@hep.physik.uni-siegen.de>
+ Thorsten Ohl <ohl@physik.uni-wuerzburg.de>
+ Juergen Reuter <juergen.reuter@physik.uni-freiburg.de>
+
+ WHIZARD is free software; you can redistribute it and/or modify it
+ under the terms of the GNU General Public License as published by
+ the Free Software Foundation; either version 2, or (at your option)
+ any later version.
+
+ WHIZARD is distributed in the hope that it will be useful, but
+ WITHOUT ANY WARRANTY; without even the implied warranty of
+ MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
+ GNU General Public License for more details.
+
+ You should have received a copy of the GNU General Public License
+ along with this program; if not, write to the Free Software
+ Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA. *)
+
+module O = Omega.Make(Fusion.Mixed23)(Targets.Fortran_Majorana)
+ (Modellib_BSM.Color6(Modellib_BSM.BSM_bsm))
+let _ = O.main ()
+
+(*i
+ * Local Variables:
+ * mode:caml
+ * indent-tabs-mode:nil
+ * page-delimiter:"^(\\* .*\n"
+ * End:
+i*)
Index: branches/color6/src/omega/tests/ac_c.flow.ects
===================================================================
--- branches/color6/src/omega/tests/ac_c.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/ac_c.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: ac_c.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model QCD
+!ects:scatter
+!ects:process gl ubar -> ubar
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 2, -1 , 0, -2 , 0, -1 , &
+ 0, 0 , 0, -1 , 0, -1 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .true., .false., .false. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (2, 2, -1.0_double) /)
+
Index: branches/color6/src/omega/tests/ca_c.flow.ects
===================================================================
--- branches/color6/src/omega/tests/ca_c.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/ca_c.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: ca_c.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model QCD
+!ects:scatter
+!ects:process ubar gl -> ubar
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 0, -2 , 2, -1 , 0, -1 , &
+ 0, -1 , 0, 0 , 0, -1 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .false., .true., .false. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (2, 2, -1.0_double) /)
+
Index: branches/color6/src/omega/tests/cf_a.flow.ects
===================================================================
--- branches/color6/src/omega/tests/cf_a.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/cf_a.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: cf_a.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model QCD
+!ects:scatter
+!ects:process ubar u -> gl
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 0, -1 , 2, 0 , 2, -1 , &
+ 0, -1 , 1, 0 , 0, 0 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .false., .false., .true. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (2, 2, -1.0_double) /)
+
Index: branches/color6/src/omega/tests/aa_s.flow.ects
===================================================================
--- branches/color6/src/omega/tests/aa_s.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/aa_s.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: aa_s.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model SYM
+!ects:scatter
+!ects:process g1 g1 -> phi
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 1, -2 , 2, -1 , 0, 0 , &
+ 0, 0 , 0, 0 , 0, 0 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .true., .true., .false. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2 - 2.0_double), &
+ OCF (2, 2, 1/NC**2) /)
+
Index: branches/color6/src/omega/tests/fc_a.flow.ects
===================================================================
--- branches/color6/src/omega/tests/fc_a.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/fc_a.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: fc_a.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model QCD
+!ects:scatter
+!ects:process u ubar -> gl
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 1, 0 , 0, -2 , 1, -2 , &
+ 1, 0 , 0, -1 , 0, 0 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .false., .false., .true. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (2, 2, -1.0_double) /)
+
Index: branches/color6/src/omega/tests/fa_f.flow.ects
===================================================================
--- branches/color6/src/omega/tests/fa_f.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/fa_f.flow.ects (revision 3984)
@@ -0,0 +1,16 @@
+! $Id: fa_f.flow.ects 3944 2012-09-12 14:18:20Z jr_reuter $
+!ects:model QCD
+!ects:scatter
+!ects:process u gl -> u
+integer, parameter :: NP = 3, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 1, 0 , 2, -1 , 2, 0 , &
+ 1, 0 , 0, 0 , 1, 0 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., &
+ .false., .true., .false. /), (/ NP, NCF /))
+type(OCF), dimension(2), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (2, 2, -1.0_double) /)
+
Index: branches/color6/src/omega/tests/fc_fc.flow.ects
===================================================================
--- branches/color6/src/omega/tests/fc_fc.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/fc_fc.flow.ects (revision 3984)
@@ -0,0 +1,18 @@
+! $Id:$
+!ects:model QCD
+!ects:scatter
+!ects:process u ubar -> d dbar
+integer, parameter :: NP = 4, NCF = 2
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 1, 0 , 0, -1 , 2, 0 , 0, -2 , &
+ 1, 0 , 0, -2 , 1, 0 , 0, -2 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false., .false., &
+ .false., .false., .false., .false. /), (/ NP, NCF /))
+type(OCF), dimension(4), parameter :: cfactors = &
+ (/ OCF (1, 1, NC**2), &
+ OCF (1, 2, NC), &
+ OCF (2, 1, NC), &
+ OCF (2, 2, NC**2) /)
+
Index: branches/color6/src/omega/tests/fc_s.flow.ects
===================================================================
--- branches/color6/src/omega/tests/fc_s.flow.ects (revision 0)
+++ branches/color6/src/omega/tests/fc_s.flow.ects (revision 3984)
@@ -0,0 +1,13 @@
+! $Id:$
+!ects:model SM
+!ects:scatter
+!ects:process u ubar -> A
+integer, parameter :: NP = 3, NCF = 1
+real(kind=default), parameter :: NC = 3
+integer, dimension(2,NP,NCF), parameter :: cflows = reshape ( &
+ (/ 1, 0 , 0, -1 , 0, 0 /), (/ 2, NP, NCF /) )
+logical, dimension(NP,NCF), parameter :: gflags = reshape ( &
+ (/ .false., .false., .false. /), (/ NP, NCF /))
+type(OCF), dimension(1), parameter :: cfactors = &
+ (/ OCF (1, 1, NC) /)
+

File Metadata

Mime Type
text/x-diff
Expires
Tue, Nov 19, 2:49 PM (1 d, 14 h)
Storage Engine
blob
Storage Format
Raw Data
Storage Handle
3804816
Default Alt Text
(21 KB)

Event Timeline