|
|
#include <TFParams.h>
|
double | computePulseWidth (int, double, double) |
|
void | copie_colonne_mat (matrice, matrice, int) |
|
void | diff_mat (matrice, matrice, matrice) |
|
double | f3deg (int, double parom[dimout], double mask[dimmat], double adcpj[dimmat], double errpj[dimmat][dimmat]) |
|
double | fitpj (double **, double *, double **, double noise_val, int debug) |
|
double | inv3x3 (double a[3][3], double b[3][3]) |
|
double | inverpj (int, double g[dimmat][dimmat], double ginv[dimmat][dimmat]) |
|
void | inverse_mat (matrice, matrice) |
|
double | lastShape (Double_t *, Double_t *) |
|
double | lastShape2 (Double_t *, Double_t *) |
|
double | mixShape (Double_t *, Double_t *) |
|
double | parab (double *, Int_t, Int_t, double *) |
|
Double_t | polfit (Int_t ns, Int_t imax, Double_t par3d[dimout], Double_t errpj[dimmat][dimmat], double *) |
|
void | print_mat (matrice) |
|
void | print_mat_nk (matrice, int) |
|
void | produit_mat (matrice, matrice, matrice) |
|
void | produit_mat_int (matrice, matrice, matrice) |
|
double | pulseShapepj (Double_t *, Double_t *) |
|
double | pulseShapepj2 (Double_t *, Double_t *) |
|
void | set_const (int, int, int, double, double, int) |
|
void | somme_mat_int (matrice, matrice) |
|
void | somme_mat_int_scale (matrice, matrice, double) |
|
| TFParams (int size=SDIM2, int size_sh=PLSHDIM) |
|
void | transpose_mat (matrice, matrice) |
|
void | zero_mat (matrice) |
|
void | zero_mat_nk (matrice, int) |
|
| ~TFParams () override |
|
|
static constexpr unsigned int | dimmat = 30 |
|
static constexpr unsigned int | dimout = 10 |
|
static constexpr unsigned int | nbmax_cell = 1000 |
|
static constexpr int | PLSHDIM = 650 |
|
static constexpr int | SDIM2 = 10 |
|
Definition at line 38 of file TFParams.h.
◆ TFParams()
TFParams::TFParams |
( |
int |
size = SDIM2 , |
|
|
int |
size_sh = PLSHDIM |
|
) |
| |
◆ ~TFParams()
◆ computePulseWidth()
double TFParams::computePulseWidth |
( |
int |
methode, |
|
|
double |
alpha_here, |
|
|
double |
beta_here |
|
) |
| |
Definition at line 1158 of file TFParams.cc.
1161 double level = 0.30;
1168 double t_min =
offset - 4.50;
1169 double t_max =
offset + 12.50;
1171 int t_step_max = 3000;
1172 double delta_t = (double)((t_max - t_min) / t_step_max);
1175 int t_amp_half_flag = 0;
1176 double t_amp_half_min = 999.;
1177 double t_amp_half_max = -999.;
1179 for (
int t_step = 0; t_step < t_step_max; t_step++) {
1180 double t_val = t_min + (double)t_step * delta_t;
1181 double albet = alpha_here * beta_here;
1186 if ((t_val -
offset) > -albet) {
1187 amp =
amplitude * TMath::Power((1 + (
dt / (alpha_here * beta_here))), alpha_here) *
1188 TMath::Exp(-1.0 * (
dt / beta_here));
1194 if (amp > (amp_max *
level) && t_amp_half_flag == 0) {
1195 t_amp_half_flag = 1;
1196 t_amp_half_min = t_val;
1199 if (amp < (amp_max *
level) && t_amp_half_flag == 1) {
1200 t_amp_half_flag = 2;
1201 t_amp_half_max = t_val;
1206 double width = (t_amp_half_max - t_amp_half_min);
References CustomPhysics_cfi::amplitude, dt, personalPlayback::level, hltrates_dqm_sourceclient-live_cfg::offset, and ApeEstimator_cff::width.
◆ copie_colonne_mat()
◆ diff_mat()
◆ f3deg()
double TFParams::f3deg |
( |
int |
nmxu, |
|
|
double |
parom[dimout], |
|
|
double |
mask[dimmat], |
|
|
double |
adcpj[dimmat], |
|
|
double |
errpj[dimmat][dimmat] |
|
) |
| |
Definition at line 805 of file TFParams.cc.
816 double xki2, dif, difmx, deglib;
820 deglib = (double)nmxu - 4.;
821 for (
i = 0;
i < nmxu;
i++) {
829 for (
k = 0;
k < 4;
k++) {
830 for (
l = 0;
l < 4;
l++) {
832 for (
i = 0;
i < nmxu;
i++) {
838 for (
i = 0;
i < nmxu;
i++) {
839 s =
s +
f[
i][
k] * adcpj[
i] * errpj[
i][
i] * mask[
i];
845 for (
k = 0;
k < 4;
k++) {
847 for (
l = 0;
l < 4;
l++) {
848 s =
s + bv[
l] * invcov[
l][
k];
853 if (parom[3] == 0.) {
862 for (
i = 0;
i < nmxu;
i++) {
864 h = parom[0] + parom[1] *
t[
i] + parom[2] *
t2 + parom[3] *
t2 *
t[
i];
865 dif = (adcpj[
i] -
h) * mask[
i];
872 xki2 = xki2 / deglib;
874 delta = parom[2] * parom[2] - 3. * parom[3] * parom[1];
877 tm = -(
delta + parom[2]) / (3. * parom[3]);
878 tmp = (
delta - parom[2]) / (3. * parom[3]);
886 parom[5] = parom[0] + parom[1] * tm + parom[2] * tm * tm + parom[3] * tm * tm * tm;
References dumpMFGeometry_cfg::delta, f, h, mps_fire::i, dqmdumpme::k, cmsLHEtoEOSManager::l, alignCSCRings::s, mathSSE::sqrt(), submitPVValidationJobs::t, RandomServiceHelper::t2, and createJobs::tmp.
◆ fitpj()
double TFParams::fitpj |
( |
double ** |
adcval, |
|
|
double * |
parout, |
|
|
double ** |
db_i, |
|
|
double |
noise_val, |
|
|
int |
debug |
|
) |
| |
Definition at line 34 of file TFParams.cc.
52 int ioktk[
ntrack], nk, nborn_min = 0, nborn_max = 0;
54 double par[4], tsig[1];
63 double albet, dtsbeta, variab,
alpha,
beta;
66 int numb_a, numb_b, numb_x;
71 matrice DA, DAT, BK,
DB, DBT,
C, CT,
D, DM1, CDM1, CDM1CT,
Z, CDM1Z, YK,
Y,
B,
X, XINV, RES2;
75 amplu =
new double[
nsamp];
92 printf(
" ------> __> valeurs de a1 %f a2 %f a3 %f\n", a1,
a2, a3);
95 for (
j = 0;
j < 2;
j++) {
96 bi[
i][
j] = (double)0.;
97 dbi[
i][
j] = (double)0.;
98 zi[
i][
j] = (double)0.;
99 cti[
i][
j] = (double)0.;
100 dm1i[
i][
j] = (double)0.;
131 A_CROISS =
cree_mat(numb_a, numb_x);
138 for (iter = 0; iter < 6; iter++) {
146 printf(
" Debut de l'iteration numero %d \n", iter);
157 printf(
" resultats injectes a iterations %d \n", iter);
158 printf(
" parametre a1 = %f \n", a1);
159 printf(
" parametre a2 = %f \n",
a2);
160 printf(
" chi2 du fit chi2s = %f \n", chi2s);
162 printf(
" value de nevtmax _______________ %d \n",
nevtmax);
187 for (
k = 0;
k < 10;
k++) {
188 amplu[
k] = adcval[
nevt][
k];
189 if (amplu[
k] > ampmax[nk]) {
190 ampmax[nk] = amplu[
k];
202 parab(amplu, 2, 9, par3degre);
211 num_fit_min[
nevt] = (double)imax[nk] - (
double)
nsmin;
212 num_fit_max[
nevt] = (double)imax[nk] + (
double)
nsmax;
214 bi[nk][0] = par3degre[0];
215 bi[nk][1] = par3degre[1];
218 printf(
"---------> depart ampmax[%d]=%f maximum %f tim %f \n", nk, ampmax[nk], bi[nk][0], bi[nk][1]);
227 bi[nk][0] += dbi[nk][0];
228 bi[nk][1] += dbi[nk][1];
231 printf(
"iter %d valeur de max %f et norma %f poly 3 \n", iter, bi[nk][1], bi[nk][0]);
244 ns = nborn_max - nborn_min + 1;
246 for (
k = 0;
k < 10;
k++) {
255 printf(
" CHECK sample %f ampli %f \n",
t, amp);
262 unsurs1 = 1. / noise_val;
269 nborn_min = (
int)num_fit_min[
nevt];
270 nborn_max = (
int)num_fit_max[
nevt];
271 if (k < nborn_min || k > nborn_max)
283 printf(
" valeur ampli %f et function %f min %d max %d \n", amp, fun,
nsmin,
nsmax);
284 printf(
"min %f max %f \n", num_fit_min[
nevt], num_fit_max[
nevt]);
298 variab = (double)1. +
dt / albet;
300 db1[
k] = unsurs1 * fun /
b1;
302 db2[
k] = unsurs1 * fact2 * dtsbeta / (albet * variab);
303 da1[
k] = unsurs1 * fact2 * (
log(variab) - dtsbeta / (
alpha * variab));
304 da2[
k] = unsurs1 * fact2 * dtsbeta * dtsbeta / (albet * variab);
307 delta[
k] = (amp - fun) * unsurs1;
309 printf(
" ------->iter %d valeur de k %d amp %f fun %f delta %f \n", iter,
k, amp, fun,
delta[
k]);
310 printf(
" -----> valeur de k %d delta %f da1 %f da2 %f \n",
k,
delta[
k], da1[
k], da2[
k]);
316 printf(
" CHECK chi2 %f deltachi2 %f sample %d iter %d \n",
chi2,
delta[
k] *
delta[
k],
k, iter);
330 for (
int k1 = nborn_min; k1 < nborn_max + 1; k1++) {
334 DA.
coeff[0][0] = da1[k1] * wk1wk2;
335 DA.
coeff[1][0] = da2[k1] * wk1wk2;
336 DAT.
coeff[0][0] = da1[k2];
337 DAT.
coeff[0][1] = da2[k2];
338 DB.coeff[0][0] = db1[k1] * wk1wk2;
339 DB.coeff[1][0] = db2[k1] * wk1wk2;
340 DBT.
coeff[0][0] = db1[k2];
341 DBT.
coeff[0][1] = db2[k2];
372 printf(
" event rejected because npamp_used = %d \n", ioktk[nk]);
375 chi2s =
chi2 / (2. + (double)
ns + 2.);
380 std::cout <<
"adc123 pour l'evt " <<
nevt <<
" = " << adcval[
nevt][nborn_min] <<
" = "
381 << adcval[
nevt][imax[
nevt]] <<
" = " << adcval[
nevt][nborn_max] << std::endl;
382 std::cout <<
"chi2s pour l'evt " <<
nevt <<
" = " << chi2s <<
" " <<
chi2 <<
" " <<
ns <<
" " << iter
384 std::cout <<
"chi2tot " <<
nevt <<
" = " << chi2tot <<
" " << iter << std::endl;
401 cti[nk][0] = CT.
coeff[0][0];
402 cti[nk][1] = CT.
coeff[0][1];
403 cti[nk][2] = CT.
coeff[1][0];
404 cti[nk][3] = CT.
coeff[1][1];
406 dm1i[nk][0] = DM1.
coeff[0][0];
407 dm1i[nk][1] = DM1.
coeff[0][1];
408 dm1i[nk][2] = DM1.
coeff[1][0];
409 dm1i[nk][3] = DM1.
coeff[1][1];
411 zi[nk][0] =
Z.coeff[0][0];
412 zi[nk][1] =
Z.coeff[1][0];
416 for (
k = 0;
k < numb_a;
k++) {
450 for (
k = 0;
k < nk + 1;
k++) {
452 ZMCT.
coeff[0][0] = zi[
k][0] - (cti[
k][0] * A_CROISS.
coeff[0][0] + cti[
k][1] * A_CROISS.
coeff[1][0]);
453 ZMCT.
coeff[1][0] = zi[
k][1] - (cti[
k][2] * A_CROISS.
coeff[0][0] + cti[
k][3] * A_CROISS.
coeff[1][0]);
456 dbi[
k][0] = dm1i[
k][0] * ZMCT.
coeff[0][0] + dm1i[
k][1] * ZMCT.
coeff[1][0];
457 dbi[
k][1] = dm1i[
k][2] * ZMCT.
coeff[0][0] + dm1i[
k][3] * ZMCT.
coeff[1][0];
460 printf(
" variations de b1= %f et b2= %f \n", dbi[
k][0], dbi[
k][1]);
463 db_i[
k][0] = bi[
k][0] + dbi[
k][0];
464 db_i[
k][1] = bi[
k][1] + dbi[
k][1];
470 a1 += A_CROISS.
coeff[0][0];
474 printf(
" CHECK croiss coef0: %f croiss coef1: %f iter %d \n",
475 fabs(A_CROISS.
coeff[0][0]),
476 fabs(A_CROISS.
coeff[1][0]),
479 if (fabs(A_CROISS.
coeff[0][0]) < 0.001 && fabs(A_CROISS.
coeff[1][0]) < 0.001)
491 printf(
" resultats trouves au bout de %d iterations \n", iter);
492 printf(
" parametre a1 = %f \n", a1);
493 printf(
" parametre a2 = %f \n",
a2);
498 std::cout <<
" Final (alpha,beta) : (" << a1 <<
"," <<
a2 <<
")" << std::endl;
References testProducerWithPsetDescEmpty_cfi::a2, alpha, TtFullHadDaughter::B, b1, b2, HLT_FULL_cff::beta, gen::C, hltPixelTracks_cff::chi2, matrice::coeff, gather_cfg::cout, cree_mat(), cree_mat_prod(), dqmPostProcessing_online::DB, debug, dumpMFGeometry_cfg::delta, dt, mps_fire::i, createfilelist::int, dqmiolumiharvest::j, dqmdumpme::k, dqm-mbProfile::log, nevt, nsamp, ntrack, submitPVValidationJobs::t, X, BeamSpotPI::Y, and BeamSpotPI::Z.
Referenced by TShapeAnalysis::computeShape().
◆ inv3x3()
double TFParams::inv3x3 |
( |
double |
a[3][3], |
|
|
double |
b[3][3] |
|
) |
| |
Definition at line 957 of file TFParams.cc.
961 b[0][0] =
a[1][1] *
a[2][2] -
a[2][1] *
a[1][2];
962 b[1][1] =
a[0][0] *
a[2][2] -
a[2][0] *
a[0][2];
963 b[2][2] =
a[0][0] *
a[1][1] -
a[0][1] *
a[1][0];
964 printf(
"a[x][x] %e %e %e %e %e %e %e \n",
972 b[0][1] =
a[2][1] *
a[0][2] -
a[0][1] *
a[2][2];
973 b[0][2] =
a[0][1] *
a[1][2] -
a[1][1] *
a[0][2];
974 b[1][0] =
a[1][2] *
a[2][0] -
a[1][0] *
a[2][2];
975 b[1][2] =
a[1][0] *
a[0][2] -
a[0][0] *
a[1][2];
976 b[2][0] =
a[1][0] *
a[2][1] -
a[1][1] *
a[2][0];
977 b[2][1] =
a[0][1] *
a[2][0] -
a[0][0] *
a[2][1];
978 deter =
a[0][0] *
b[0][0] +
a[1][0] *
b[0][1] +
a[2][0] *
b[0][2];
979 printf(
" deter = %e \n", deter);
980 for (
i = 0;
i < 3;
i++) {
981 for (
j = 0;
j < 3;
j++) {
982 printf(
" avant division a[3][3] %d %d %e \n",
i,
j,
a[
i][
j]);
983 printf(
" avant division b[3][3] %d %d %e %e \n",
i,
j,
b[
i][
j], deter);
984 b[
i][
j] =
b[
i][
j] / deter;
985 printf(
" valeur de b[3][3] apres division %d %d %e %e \n",
i,
j,
b[
i][
j], deter);
References a, b, mps_fire::i, and dqmiolumiharvest::j.
◆ inverpj()
double TFParams::inverpj |
( |
int |
n, |
|
|
double |
g[dimmat][dimmat], |
|
|
double |
ginv[dimmat][dimmat] |
|
) |
| |
◆ inverse_mat()
Definition at line 719 of file TFParams.cc.
725 if (
A.nb_lignes !=
A.nb_colonnes) {
726 printf(
" attention matrice non inversible !!!! %d lignes %d colonnes \n",
A.nb_lignes,
A.nb_colonnes);
730 if (
A.nb_lignes == 2) {
731 deter =
A.coeff[0][0] *
A.coeff[1][1] -
A.coeff[0][1] *
A.coeff[1][0];
732 M.
coeff[0][0] =
A.coeff[1][1] / deter;
733 M.
coeff[0][1] = -
A.coeff[0][1] / deter;
734 M.
coeff[1][0] = -
A.coeff[1][0] / deter;
735 M.
coeff[1][1] =
A.coeff[0][0] / deter;
736 }
else if (
A.nb_lignes == 3) {
737 M.
coeff[0][0] =
A.coeff[1][1] *
A.coeff[2][2] -
A.coeff[2][1] *
A.coeff[1][2];
738 M.
coeff[1][1] =
A.coeff[0][0] *
A.coeff[2][2] -
A.coeff[2][0] *
A.coeff[0][2];
740 M.
coeff[2][2] =
A.coeff[0][0] *
A.coeff[1][1] -
A.coeff[0][1] *
A.coeff[1][0];
741 M.
coeff[0][1] =
A.coeff[2][1] *
A.coeff[0][2] -
A.coeff[0][1] *
A.coeff[2][2];
742 M.
coeff[0][2] =
A.coeff[0][1] *
A.coeff[1][2] -
A.coeff[1][1] *
A.coeff[0][2];
743 M.
coeff[1][0] =
A.coeff[1][2] *
A.coeff[2][0] -
A.coeff[1][0] *
A.coeff[2][2];
744 M.
coeff[1][2] =
A.coeff[1][0] *
A.coeff[0][2] -
A.coeff[0][0] *
A.coeff[1][2];
745 M.
coeff[2][0] =
A.coeff[1][0] *
A.coeff[2][1] -
A.coeff[1][1] *
A.coeff[2][0];
746 M.
coeff[2][1] =
A.coeff[0][1] *
A.coeff[2][0] -
A.coeff[0][0] *
A.coeff[2][1];
747 deter =
A.coeff[0][0] * M.
coeff[0][0] +
A.coeff[1][0] * M.
coeff[0][1] +
A.coeff[2][0] * M.
coeff[0][2];
748 for (
i = 0;
i < 3;
i++) {
749 for (
j = 0;
j < 3;
j++)
753 printf(
" Attention , on ne peut inverser la MATRICE %d \n",
A.nb_lignes);
References matrice::coeff, mps_fire::i, and dqmiolumiharvest::j.
◆ lastShape()
double TFParams::lastShape |
( |
Double_t * |
x, |
|
|
Double_t * |
par |
|
) |
| |
◆ lastShape2()
double TFParams::lastShape2 |
( |
Double_t * |
x, |
|
|
Double_t * |
par |
|
) |
| |
◆ mixShape()
double TFParams::mixShape |
( |
Double_t * |
x, |
|
|
Double_t * |
par |
|
) |
| |
Definition at line 1128 of file TFParams.cc.
1129 Double_t fitval0, fitval;
1132 Double_t
b1,
b2, alpha2,
t;
1150 alpha2dt =
dt * alpha2;
References alpha, b1, b2, HLT_FULL_cff::beta, dt, JetChargeProducer_cfi::exp, HLT_FULL_cff::exponent, fact, funct::pow(), and submitPVValidationJobs::t.
◆ parab()
double TFParams::parab |
( |
double * |
, |
|
|
Int_t |
, |
|
|
Int_t |
, |
|
|
double * |
|
|
) |
| |
Definition at line 1091 of file TFParams.cc.
1095 double denom,
dt, amp1, amp2, amp3;
1101 for (
k =
nmin;
k < nmax;
k++) {
1102 if (ampl[
k] > ampmax) {
1107 amp1 = ampl[imax - 1];
1109 amp3 = ampl[imax + 1];
1110 denom = 2. * amp2 - amp1 - amp3;
1113 dt = 0.5 * (amp3 - amp1) /
denom;
1122 parout[0] = amp2 + (amp3 - amp1) *
dt * 0.25;
1123 parout[1] = (double)imax +
dt;
1124 parout[2] = (double)imax;
References makePileupJSON::denom, dt, dqmdumpme::k, and nmin.
◆ polfit()
Double_t TFParams::polfit |
( |
Int_t |
ns, |
|
|
Int_t |
imax, |
|
|
Double_t |
par3d[dimout], |
|
|
Double_t |
errpj[dimmat][dimmat], |
|
|
double * |
adcpj |
|
) |
| |
Definition at line 759 of file TFParams.cc.
762 double deglib, fit3, tm,
h, xki2;
763 int i, nus, ilow, isup;
770 for (
i = 0;
i <
ns;
i++) {
771 deglib = deglib + 1.;
773 if ((adcpj[
i] < val3) && (
i < imax)) {
776 if (adcpj[
i] > val2) {
786 for (
i = ilow;
i <= isup;
i++) {
787 adfmx[nus] = adcpj[
i];
796 xki2 =
f3deg(nus, parfp3, maskp3, adfmx, errpj);
799 tm = tm + (double)ilow;
References h, mps_fire::i, and heppy_batch::val.
◆ print_mat()
void TFParams::print_mat |
( |
matrice |
M | ) |
|
◆ print_mat_nk()
void TFParams::print_mat_nk |
( |
matrice |
M, |
|
|
int |
nk |
|
) |
| |
◆ produit_mat()
◆ produit_mat_int()
◆ pulseShapepj()
double TFParams::pulseShapepj |
( |
Double_t * |
x, |
|
|
Double_t * |
par |
|
) |
| |
Definition at line 991 of file TFParams.cc.
994 Double_t
dt, dtsbeta, albet, variab, puiss;
1010 return ((Double_t)0.);
1014 variab = 1. +
dt / albet;
1016 fitfun =
h * puiss *
exp(-dtsbeta) + ped;
References testProducerWithPsetDescEmpty_cfi::a2, alpha, b1, b2, HLT_FULL_cff::beta, dt, JetChargeProducer_cfi::exp, h, and funct::pow().
◆ pulseShapepj2()
Double_t TFParams::pulseShapepj2 |
( |
Double_t * |
x, |
|
|
Double_t * |
par |
|
) |
| |
Definition at line 1058 of file TFParams.cc.
1061 Double_t
dt, dtsbeta, albet, variab, puiss;
1062 Double_t
b1, a1,
a2;
1075 return ((Double_t)0.);
1079 variab = 1. +
dt / albet;
1081 fitfun =
h * puiss *
exp(-dtsbeta) + ped;
References testProducerWithPsetDescEmpty_cfi::a2, alpha, b1, HLT_FULL_cff::beta, dt, JetChargeProducer_cfi::exp, h, and funct::pow().
◆ set_const()
void TFParams::set_const |
( |
int |
n_samples, |
|
|
int |
sample_min, |
|
|
int |
sample_max, |
|
|
double |
alpha, |
|
|
double |
beta, |
|
|
int |
nevtmaximum |
|
) |
| |
◆ somme_mat_int()
◆ somme_mat_int_scale()
void TFParams::somme_mat_int_scale |
( |
matrice |
A, |
|
|
matrice |
M, |
|
|
double |
delta |
|
) |
| |
◆ transpose_mat()
◆ zero_mat()
void TFParams::zero_mat |
( |
matrice |
M | ) |
|
◆ zero_mat_nk()
void TFParams::zero_mat_nk |
( |
matrice |
M, |
|
|
int |
nk |
|
) |
| |
◆ a1ini
◆ a2ini
◆ a3ini
◆ adclu
double TFParams::adclu[26] |
|
private |
◆ dimmat
constexpr unsigned int TFParams::dimmat = 30 |
|
staticconstexpr |
◆ dimout
constexpr unsigned int TFParams::dimout = 10 |
|
staticconstexpr |
◆ METHODE
◆ name_mat
char TFParams::name_mat[10] |
◆ nbmax_cell
constexpr unsigned int TFParams::nbmax_cell = 1000 |
|
staticconstexpr |
◆ nevtmax
◆ ns
◆ nsmax
◆ nsmin
◆ PLSHDIM
constexpr int TFParams::PLSHDIM = 650 |
|
staticconstexpr |
◆ SDIM2
constexpr int TFParams::SDIM2 = 10 |
|
staticconstexpr |
◆ step_shape
double TFParams::step_shape |
|
private |
◆ weight_matrix
double TFParams::weight_matrix[10][10] |
|
private |
FWCore Framework interface EventSetupRecordImplementation h
Helper function to determine trigger accepts.
static constexpr unsigned int dimout
double inverpj(int, double g[dimmat][dimmat], double ginv[dimmat][dimmat])
static constexpr float b2
static constexpr float b1
void somme_mat_int_scale(matrice, matrice, double)
void somme_mat_int(matrice, matrice)
static constexpr int SDIM2
double weight_matrix[10][10]
const HitContainer *__restrict__ const TkSoA *__restrict__ Quality *__restrict__ uint16_t nmin
void produit_mat_int(matrice, matrice, matrice)
void produit_mat(matrice, matrice, matrice)
static constexpr unsigned int dimmat
double parab(double *, Int_t, Int_t, double *)
static const std::string B
DecomposeProduct< arg, typename Div::arg > D
double pulseShapepj(Double_t *, Double_t *)
void transpose_mat(matrice, matrice)
matrice cree_mat(int n_lignes, int n_colonnes)
double f3deg(int, double parom[dimout], double mask[dimmat], double adcpj[dimmat], double errpj[dimmat][dimmat])
matrice cree_mat_prod(matrice A, matrice B)
Power< A, B >::type pow(const A &a, const B &b)
void inverse_mat(matrice, matrice)
void diff_mat(matrice, matrice, matrice)
The Signals That Services Can Subscribe To This is based on ActivityRegistry and is current per Services can connect to the signals distributed by the ActivityRegistry in order to monitor the activity of the application Each possible callback has some defined which we here list in angle e g