Skip to content
Merged
Show file tree
Hide file tree
Changes from all commits
Commits
File filter

Filter by extension

Filter by extension

Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
2 changes: 1 addition & 1 deletion Detectors/Align/Workflow/src/BarrelAlignmentSpec.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -265,7 +265,7 @@ void BarrelAlignmentSpec::updateTimeDependentParams(ProcessingContext& pc)
prevField = newField;
if (mDetMask[DetID::TPC]) {
mTPCParam.reset(new o2::gpu::GPUParam);
mTPCParam->SetDefaults(o2::base::Propagator::Instance()->getNominalBz());
mTPCParam->SetDefaults(o2::base::Propagator::Instance()->getNominalBz(), false);
mController->setTPCParam(mTPCParam.get());
}
}
Expand Down
25 changes: 9 additions & 16 deletions GPU/GPUTracking/Base/GPUParam.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -30,7 +30,7 @@ using namespace o2::gpu;

#include "utils/qconfigrtc.h"

void GPUParam::SetDefaults(float solenoidBz)
void GPUParam::SetDefaults(float solenoidBz, bool assumeConstantBz)
{
memset((void*)this, 0, sizeof(*this));
new (&rec) GPUSettingsRec;
Expand Down Expand Up @@ -83,8 +83,7 @@ void GPUParam::SetDefaults(float solenoidBz)
}
#endif

par.dAlpha = 0.349066f;
UpdateBzOnly(solenoidBz);
UpdateBzOnly(solenoidBz, assumeConstantBz);
par.dodEdx = 0;

constexpr float plusZmin = 0.0529937;
Expand All @@ -102,36 +101,30 @@ void GPUParam::SetDefaults(float solenoidBz)
if (tmp >= GPUCA_NSECTORS / 4) {
tmp -= GPUCA_NSECTORS / 2;
}
SectorParam[i].Alpha = 0.174533f + par.dAlpha * tmp;
SectorParam[i].Alpha = 0.174533f + dAlpha * tmp;
SectorParam[i].CosAlpha = CAMath::Cos(SectorParam[i].Alpha);
SectorParam[i].SinAlpha = CAMath::Sin(SectorParam[i].Alpha);
SectorParam[i].AngleMin = SectorParam[i].Alpha - par.dAlpha / 2.f;
SectorParam[i].AngleMax = SectorParam[i].Alpha + par.dAlpha / 2.f;
SectorParam[i].AngleMin = SectorParam[i].Alpha - dAlpha / 2.f;
SectorParam[i].AngleMax = SectorParam[i].Alpha + dAlpha / 2.f;
}

par.assumeConstantBz = false;
par.toyMCEventsFlag = false;
par.continuousTracking = false;
continuousMaxTimeBin = 0;
tpcCutTimeBin = 0;
par.debugLevel = 0;
par.earlyTpcTransform = false;
}

void GPUParam::UpdateSettings(const GPUSettingsGRP* g, const GPUSettingsProcessing* p, const GPURecoStepConfiguration* w, const GPUSettingsRecDynamic* d)
{
if (g) {
UpdateBzOnly(g->solenoidBzNominalGPU);
par.assumeConstantBz = g->constBz;
par.toyMCEventsFlag = g->homemadeEvents;
UpdateBzOnly(g->solenoidBzNominalGPU, g->constBz);
par.continuousTracking = g->grpContinuousMaxTimeBin != 0;
continuousMaxTimeBin = g->grpContinuousMaxTimeBin == -1 ? GPUSettings::TPC_MAX_TF_TIME_BIN : g->grpContinuousMaxTimeBin;
tpcCutTimeBin = g->tpcCutTimeBin;
}
par.earlyTpcTransform = rec.tpc.forceEarlyTransform == -1 ? (!par.continuousTracking) : rec.tpc.forceEarlyTransform;
qptB5Scaler = CAMath::Abs(bzkG) > 0.1f ? CAMath::Abs(bzkG) / 5.006680f : 1.f; // Repeat here, since passing in g is optional
if (p) {
par.debugLevel = p->debugLevel;
UpdateRun3ClusterErrors(p->param.tpcErrorParamY, p->param.tpcErrorParamZ);
}
if (w) {
Expand All @@ -145,12 +138,12 @@ void GPUParam::UpdateSettings(const GPUSettingsGRP* g, const GPUSettingsProcessi
}
}

void GPUParam::UpdateBzOnly(float newSolenoidBz)
void GPUParam::UpdateBzOnly(float newSolenoidBz, bool assumeConstantBz)
{
bzkG = newSolenoidBz;
bzCLight = bzkG * o2::gpu::gpu_common_constants::kCLight;
polynomialField.Reset();
if (par.assumeConstantBz) {
if (assumeConstantBz) {
GPUTPCGMPolynomialFieldManager::GetPolynomialField(GPUTPCGMPolynomialFieldManager::kUniform, bzkG, polynomialField);
} else {
GPUTPCGMPolynomialFieldManager::GetPolynomialField(bzkG, polynomialField);
Expand All @@ -160,7 +153,7 @@ void GPUParam::UpdateBzOnly(float newSolenoidBz)

void GPUParam::SetDefaults(const GPUSettingsGRP* g, const GPUSettingsRec* r, const GPUSettingsProcessing* p, const GPURecoStepConfiguration* w)
{
SetDefaults(g->solenoidBzNominalGPU);
SetDefaults(g->solenoidBzNominalGPU, g->constBz);
if (r) {
rec = *r;
if (rec.fitPropagateBzOnly == -1) {
Expand Down
8 changes: 5 additions & 3 deletions GPU/GPUTracking/Base/GPUParam.h
Original file line number Diff line number Diff line change
Expand Up @@ -47,6 +47,8 @@ namespace internal
{
template <class T, class S>
struct GPUParam_t {
static constexpr float dAlpha = 0.349066f;

T rec;
S par;

Expand Down Expand Up @@ -77,10 +79,10 @@ struct GPUParam_t {
struct GPUParam : public internal::GPUParam_t<GPUSettingsRec, GPUSettingsParam> {

#ifndef GPUCA_GPUCODE
void SetDefaults(float solenoidBz);
void SetDefaults(float solenoidBz, bool assumeConstantBz);
void SetDefaults(const GPUSettingsGRP* g, const GPUSettingsRec* r = nullptr, const GPUSettingsProcessing* p = nullptr, const GPURecoStepConfiguration* w = nullptr);
void UpdateSettings(const GPUSettingsGRP* g, const GPUSettingsProcessing* p = nullptr, const GPURecoStepConfiguration* w = nullptr, const GPUSettingsRecDynamic* d = nullptr);
void UpdateBzOnly(float newSolenoidBz);
void UpdateBzOnly(float newSolenoidBz, bool assumeConstantBz);
void UpdateRun3ClusterErrors(const float* yErrorParam, const float* zErrorParam);
#endif

Expand All @@ -92,7 +94,7 @@ struct GPUParam : public internal::GPUParam_t<GPUSettingsRec, GPUSettingsParam>
if (iSector >= GPUCA_NSECTORS / 4) {
iSector -= GPUCA_NSECTORS / 2;
}
return 0.174533f + par.dAlpha * iSector;
return 0.174533f + dAlpha * iSector;
}
GPUd() float GetClusterErrorSeeding(int32_t yz, int32_t type, float zDiff, float angle2, float unscaledMult) const;
GPUd() void GetClusterErrorsSeeding2(uint8_t sector, int32_t row, float z, float sinPhi, float DzDs, float time, float& ErrY2, float& ErrZ2) const;
Expand Down
3 changes: 1 addition & 2 deletions GPU/GPUTracking/Base/GPUReconstructionTimeframe.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -25,14 +25,13 @@
#include "TPCFastTransform.h"
#include "CorrectionMapsHelper.h"
#include "GPUO2DataTypes.h"
#include "GPUSettings.h"

#include <cstdio>
#include <exception>
#include <memory>
#include <cstring>

#include "utils/qconfig.h"

using namespace o2::gpu;

namespace o2::gpu
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -27,7 +27,6 @@ GPUd() void GPUTPCCompressionTrackModel::Init(float x, float y, float z, float a
{
mProp.SetMaterialTPC();
mProp.SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
mProp.SetToyMCEventsFlag(false);
mProp.SetSeedingErrors(true); // Larger errors for seeds, better since we don't start with good hypothesis
mProp.SetFitInProjections(true);
mProp.SetPropagateBzOnly(true);
Expand Down
2 changes: 1 addition & 1 deletion GPU/GPUTracking/DataTypes/GPUSettings.h
Original file line number Diff line number Diff line change
Expand Up @@ -52,7 +52,7 @@ struct GPUSettingsGRP {
// All new members must be sizeof(int32_t) resp. sizeof(float) for alignment reasons!, default value for newly added members for old data will be 0.
float solenoidBzNominalGPU = -5.00668f; // solenoid field strength
int32_t constBz = 0; // for test-MC events with constant Bz
int32_t homemadeEvents = 0; // Toy-MC events
int32_t removed0 = 0; // Obsolete parameter, dummy value needed to support reading old dumps
int32_t grpContinuousMaxTimeBin = -2; // 0 for triggered events, -1 for automatic setting, -2 invalid default
int32_t needsClusterer = 0; // Set to true if the data requires the clusterizer
int32_t doCompClusterDecode = 0; // Set to true if the data contains compressed TPC clusters
Expand Down
4 changes: 0 additions & 4 deletions GPU/GPUTracking/Definitions/GPUSettingsList.h
Original file line number Diff line number Diff line change
Expand Up @@ -650,13 +650,9 @@ EndConfig()

// Derrived parameters used in GPUParam
BeginHiddenConfig(GPUSettingsParam, param)
AddVariableRTC(dAlpha, float, 0.f) // angular size
AddVariableRTC(assumeConstantBz, int8_t, 0) // Assume a constant magnetic field
AddVariableRTC(toyMCEventsFlag, int8_t, 0) // events were build with home-made event generator
AddVariableRTC(continuousTracking, int8_t, 0) // Continuous tracking, estimate bz and errors for abs(z) = 125cm during seeding
AddVariableRTC(dodEdx, int8_t, 0) // Do dEdx computation
AddVariableRTC(earlyTpcTransform, int8_t, 0) // do Early TPC transformation
AddVariableRTC(debugLevel, int8_t, 0) // Debug level
EndConfig()

EndNamespace() // gpu
Expand Down
1 change: 0 additions & 1 deletion GPU/GPUTracking/ITS/GPUITSFitterKernels.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -63,7 +63,6 @@ GPUdii() void GPUITSFitterKernels::Thread<0>(int32_t nBlocks, int32_t nThreads,
GPUTPCGMPropagator prop;
prop.SetPolynomialField(&processors.param.polynomialField);
prop.SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
prop.SetToyMCEventsFlag(0);
prop.SetFitInProjections(1);
float bz = -5.f; // FIXME

Expand Down
2 changes: 1 addition & 1 deletion GPU/GPUTracking/Interface/GPUO2InterfaceDisplay.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -35,7 +35,7 @@ GPUO2InterfaceDisplay::GPUO2InterfaceDisplay(const GPUO2InterfaceConfiguration*
mQA.reset(new GPUQA(nullptr, &config->configQA, mParam.get()));
mQA->InitO2MCData();
}
mDisplay.reset(GPUDisplayInterface::getDisplay(mFrontend.get(), nullptr, mQA.get(), mParam.get(), &mConfig->configCalib, &mConfig->configDisplay));
mDisplay.reset(GPUDisplayInterface::getDisplay(mFrontend.get(), nullptr, mQA.get(), mParam.get(), &mConfig->configCalib, &mConfig->configDisplay, &mConfig->configProcessing));
}

GPUO2InterfaceDisplay::~GPUO2InterfaceDisplay() = default;
Expand Down
2 changes: 1 addition & 1 deletion GPU/GPUTracking/Interface/GPUO2InterfaceRefit.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -129,7 +129,7 @@ GPUO2InterfaceRefit::GPUO2InterfaceRefit(const ClusterNativeAccess* cl, const Co

void GPUO2InterfaceRefit::updateCalib(const CorrectionMapsHelper* trans, float bzNominalGPU)
{
mParam->UpdateBzOnly(bzNominalGPU);
mParam->UpdateBzOnly(bzNominalGPU, false);
mRefit->SetFastTransformHelper(trans);
}

Expand Down
2 changes: 1 addition & 1 deletion GPU/GPUTracking/Interface/GPUO2InterfaceUtils.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -51,7 +51,7 @@ template <>
void GPUO2InterfaceUtils::RunZSEncoder<DigitArray>(const DigitArray& in, std::unique_ptr<uint64_t[]>* outBuffer, uint32_t* outSizes, o2::raw::RawFileWriter* raw, const o2::InteractionRecord* ir, int32_t version, bool verify, float threshold, bool padding, std::function<void(std::vector<o2::tpc::Digit>&)> digitsFilter)
{
GPUParam param;
param.SetDefaults(5.00668);
param.SetDefaults(5.00668, false);
o2::gpu::GPUReconstructionConvert::RunZSEncoder(in, outBuffer, outSizes, raw, ir, param, version, verify, threshold, padding, digitsFilter);
}
template <>
Expand Down
3 changes: 1 addition & 2 deletions GPU/GPUTracking/Merger/GPUTPCGMMerger.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -493,7 +493,6 @@ GPUd() int32_t GPUTPCGMMerger::RefitSectorTrack(GPUTPCGMSectorTrack& sectorTrack
GPUTPCGMPropagator prop;
prop.SetMaterialTPC();
prop.SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
prop.SetToyMCEventsFlag(false);
prop.SetSeedingErrors(true); // Larger errors for seeds, better since we don't start with good hypothesis
prop.SetFitInProjections(false);
prop.SetPolynomialField(&Param().polynomialField);
Expand Down Expand Up @@ -666,7 +665,7 @@ GPUd() void GPUTPCGMMerger::MergeSectorsPrepareStep2(int32_t nBlocks, int32_t nT

float fieldBz = Param().bzCLight;

float dAlpha = Param().par.dAlpha / 2;
float dAlpha = Param().dAlpha / 2;
float x0 = 0;

if (iBorder == 0) { // transport to the left edge of the sector and rotate horizontally
Expand Down
21 changes: 3 additions & 18 deletions GPU/GPUTracking/Merger/GPUTPCGMPropagator.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -74,23 +74,10 @@ GPUd() void GPUTPCGMPropagator::GetBxByBzBase(float cosAlpha, float sinAlpha, fl
B[0] = bb[0] * cosAlpha + bb[1] * sinAlpha;
B[1] = -bb[0] * sinAlpha + bb[1] * cosAlpha;
B[2] = bb[2];
/*if( mToyMCEvents ){ // special treatment for toy monte carlo
B[0] = 0;
B[1] = 0;
B[2] = mField->GetNominalBz();
}*/
}

GPUd() float GPUTPCGMPropagator::GetBzBase(float cosAlpha, float sinAlpha, float X, float Y, float Z) const
{
if (mToyMCEvents) { // special treatment for toy monte carlo
float B[3];
GetBxByBzBase(cosAlpha, sinAlpha, X, Y, Z, B);
return B[2];
}

// get global coordinates

float gx = getGlobalX(cosAlpha, sinAlpha, X, Y);
float gy = getGlobalY(cosAlpha, sinAlpha, X, Y);

Expand Down Expand Up @@ -529,8 +516,7 @@ GPUd() int32_t GPUTPCGMPropagator::FollowLinearization(const GPUTPCGMPhysicalTra
float dLabs = CAMath::Abs(dLmask);

// Energy Loss

if (1 || !mToyMCEvents) {
if (true) {
// std::cout<<"APPLY ENERGY LOSS!!!"<<std::endl;
float corr = 1.f - mMaterial.EP2 * dLmask;
float corrInv = 1.f / corr;
Expand All @@ -553,8 +539,7 @@ GPUd() int32_t GPUTPCGMPropagator::FollowLinearization(const GPUTPCGMPhysicalTra
}

// Multiple Scattering

if (!mToyMCEvents) {
if (true) {
mC22 += dLabs * mMaterial.k22 * mT0.CosPhi() * mT0.CosPhi();
mC33 += dLabs * mMaterial.k33;
mC43 += dLabs * mMaterial.k43;
Expand Down Expand Up @@ -1038,7 +1023,7 @@ GPUd() void GPUTPCGMPropagator::Mirror(bool inFlyDirection)
ChangeDirection();

// Energy Loss
if (1 || !mToyMCEvents) {
if (true) {
// std::cout<<"MIRROR: APPLY ENERGY LOSS!!!"<<std::endl;

float dL = CAMath::Abs(dS * mT0.GetDlDs());
Expand Down
2 changes: 0 additions & 2 deletions GPU/GPUTracking/Merger/GPUTPCGMPropagator.h
Original file line number Diff line number Diff line change
Expand Up @@ -89,7 +89,6 @@ class GPUTPCGMPropagator

GPUd() void SetFitInProjections(bool Flag) { mFitInProjections = Flag; }
GPUd() void SetPropagateBzOnly(bool Flag) { mPropagateBzOnly = Flag; }
GPUd() void SetToyMCEventsFlag(bool Flag) { mToyMCEvents = Flag; }
GPUd() void SetSeedingErrors(bool Flag) { mSeedingErrors = Flag; }
GPUd() void SetMatLUT(const o2::base::MatLayerCylSet* lut) { mMatLUT = lut; }

Expand Down Expand Up @@ -191,7 +190,6 @@ class GPUTPCGMPropagator
bool mSeedingErrors = 0; // TODO: Hide variable in Run3 mode
bool mFitInProjections = 1; // fit (Y,SinPhi,QPt) and (Z,DzDs) paramteres separatelly
bool mPropagateBzOnly = 0; // Use Bz only in propagation
bool mToyMCEvents = 0; // events are simulated with simple home-made simulation
};

GPUdi() void GPUTPCGMPropagator::GetBxByBz(float Alpha, float X, float Y, float Z, float B[3]) const
Expand Down
4 changes: 1 addition & 3 deletions GPU/GPUTracking/Merger/GPUTPCGMTrackParam.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -42,7 +42,7 @@
#include "GPUGetConstexpr.h"

#ifdef GPUCA_CADEBUG_ENABLED
#include "../utils/qconfig.h"
#include "GPUSettings.h"
#include "AliHLTTPCClusterMCData.h"
#endif

Expand All @@ -67,7 +67,6 @@ GPUd() bool GPUTPCGMTrackParam::Fit(GPUTPCGMMerger* GPUrestrict() merger, int32_
prop.SetMaterialTPC();
prop.SetPolynomialField(&param.polynomialField);
prop.SetMaxSinPhi(maxSinPhi);
prop.SetToyMCEventsFlag(param.par.toyMCEventsFlag);
if ((clusters[0].sector < 18) == (clusters[N - 1].sector < 18)) {
ShiftZ2(clusters, clustersXYZ, merger, N);
}
Expand Down Expand Up @@ -744,7 +743,6 @@ GPUdii() void GPUTPCGMTrackParam::RefitLoop(const GPUTPCGMMerger* GPUrestrict()
prop.SetMaterialTPC();
prop.SetPolynomialField(&Merger->Param().polynomialField);
prop.SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
prop.SetToyMCEventsFlag(Merger->Param().par.toyMCEventsFlag);
prop.SetMatLUT(Merger->Param().rec.useMatLUT ? Merger->GetConstantMem()->calibObjects.matLUT : nullptr);
prop.SetSeedingErrors(false);
prop.SetFitInProjections(true);
Expand Down
1 change: 0 additions & 1 deletion GPU/GPUTracking/Merger/macros/checkPropagation.C
Original file line number Diff line number Diff line change
Expand Up @@ -91,7 +91,6 @@ int32_t checkPropagation()

GPUTPCGMPropagator prop;
prop.SetPolynomialField(&field);
prop.SetToyMCEventsFlag(kTRUE);

const int32_t nTracks = 1000;

Expand Down
1 change: 0 additions & 1 deletion GPU/GPUTracking/Refit/GPUTrackingRefit.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -88,7 +88,6 @@ GPUd() void GPUTrackingRefit::initProp<GPUgeneric() GPUTPCGMPropagator>(GPUTPCGM
{
prop.SetMaterialTPC();
prop.SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
prop.SetToyMCEventsFlag(false);
prop.SetSeedingErrors(false);
prop.SetFitInProjections(mPparam->rec.fitInProjections != 0);
prop.SetPropagateBzOnly(false);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -129,11 +129,11 @@ GPUd() void GPUTPCExtrapolationTracking::PerformExtrapolationTracking(int32_t nB
float Y = (float)tracker.Data().HitDataY(row, tracker.TrackHits()[tmpHit].HitIndex()) * row.HstepY() + row.Grid().YMin();
if (!right && Y < -row.MaxY() * tracker.Param().rec.tpc.extrapolationTrackingYRangeLower) {
// GPUInfo("Track %d, lower row %d, left border (%f of %f)", i, mTrackHits[tmpHit].RowIndex(), Y, -row.MaxY());
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, -tracker.Param().par.dAlpha, -1);
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, -tracker.Param().dAlpha, -1);
}
if (right && Y > row.MaxY() * tracker.Param().rec.tpc.extrapolationTrackingYRangeLower) {
// GPUInfo("Track %d, lower row %d, right border (%f of %f)", i, mTrackHits[tmpHit].RowIndex(), Y, row.MaxY());
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, tracker.Param().par.dAlpha, -1);
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, tracker.Param().dAlpha, -1);
}
}
}
Expand All @@ -146,11 +146,11 @@ GPUd() void GPUTPCExtrapolationTracking::PerformExtrapolationTracking(int32_t nB
float Y = (float)tracker.Data().HitDataY(row, tracker.TrackHits()[tmpHit].HitIndex()) * row.HstepY() + row.Grid().YMin();
if (!right && Y < -row.MaxY() * tracker.Param().rec.tpc.extrapolationTrackingYRangeUpper) {
// GPUInfo("Track %d, upper row %d, left border (%f of %f)", i, mTrackHits[tmpHit].RowIndex(), Y, -row.MaxY());
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, -tracker.Param().par.dAlpha, 1);
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, -tracker.Param().dAlpha, 1);
}
if (right && Y > row.MaxY() * tracker.Param().rec.tpc.extrapolationTrackingYRangeUpper) {
// GPUInfo("Track %d, upper row %d, right border (%f of %f)", i, mTrackHits[tmpHit].RowIndex(), Y, row.MaxY());
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, tracker.Param().par.dAlpha, 1);
PerformExtrapolationTrackingRun(sectorTarget, smem, tracker, i, rowIndex, tracker.Param().dAlpha, 1);
}
}
}
Expand Down
2 changes: 1 addition & 1 deletion GPU/GPUTracking/SectorTracker/GPUTPCTrackingData.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@ void GPUTPCTrackingData::InitializeRows(const GPUParam& p)
}
for (int32_t i = 0; i < GPUCA_ROW_COUNT; i++) {
mRows[i].mX = GPUTPCGeometry::Row2X(i);
mRows[i].mMaxY = CAMath::Tan(p.par.dAlpha / 2.f) * mRows[i].mX;
mRows[i].mMaxY = CAMath::Tan(p.dAlpha / 2.f) * mRows[i].mX;
}
}

Expand Down
5 changes: 1 addition & 4 deletions GPU/GPUTracking/Standalone/Benchmark/standalone.cxx
Original file line number Diff line number Diff line change
Expand Up @@ -286,7 +286,7 @@ int32_t SetupReconstruction()
printf("Error reading event config file\n");
return 1;
}
printf("Read event settings from dir %s (solenoidBz: %f, home-made events %d, constBz %d, maxTimeBin %d)\n", filename, rec->GetGRPSettings().solenoidBzNominalGPU, (int32_t)rec->GetGRPSettings().homemadeEvents, (int32_t)rec->GetGRPSettings().constBz, rec->GetGRPSettings().grpContinuousMaxTimeBin);
printf("Read event settings from dir %s (solenoidBz: %f, constBz %d, maxTimeBin %d)\n", filename, rec->GetGRPSettings().solenoidBzNominalGPU, (int32_t)rec->GetGRPSettings().constBz, rec->GetGRPSettings().grpContinuousMaxTimeBin);
if (configStandalone.testSyncAsync) {
recAsync->ReadSettings(filename);
}
Expand All @@ -305,9 +305,6 @@ int32_t SetupReconstruction()
procSet = configStandalone.proc;
GPURecoStepConfiguration steps;

if (configStandalone.eventGenerator) {
grp.homemadeEvents = true;
}
if (configStandalone.solenoidBzNominalGPU != -1e6f) {
grp.solenoidBzNominalGPU = configStandalone.solenoidBzNominalGPU;
}
Expand Down
1 change: 0 additions & 1 deletion GPU/GPUTracking/TRDTracking/GPUTRDInterfaces.h
Original file line number Diff line number Diff line change
Expand Up @@ -187,7 +187,6 @@ class propagatorInterface<GPUTPCGMPropagator> : public GPUTPCGMPropagator
this->SetMaterialTPC();
this->SetPolynomialField(pField);
this->SetMaxSinPhi(GPUCA_MAX_SIN_PHI);
this->SetToyMCEventsFlag(0);
this->SetFitInProjections(0);
this->SelectFieldRegion(GPUTPCGMPropagator::TRD);
};
Expand Down
Loading