Xmipp  v3.23.11-Nereus
Public Member Functions | Public Attributes | List of all members
ProgTomoSimulateTiltseries Class Reference

#include <tomo_simulate_tilt_series.h>

Inheritance diagram for ProgTomoSimulateTiltseries:
Inheritance graph
[legend]
Collaboration diagram for ProgTomoSimulateTiltseries:
Collaboration graph
[legend]

Public Member Functions

void readParams ()
 Read argument from command line. More...
 
void createFiducial (MultidimArray< double > &fidImage, int boxsize)
 create fiducial More...
 
void createSphere (MultidimArray< int > &mask, int boxsize)
 create a cirte to limit the projection extension More...
 
void maskingRotatedSubtomo (MultidimArray< double > &subtomo, int boxsize)
 
void placeSubtomoInTomo (const MultidimArray< double > &subtomo, MultidimArray< double > &tomo, const int xcoord, const int ycoord, const int zcood, const size_t halfboxsize)
 
void createFiducial (MultidimArray< double > &fidImage, MultidimArray< double > &fidVol, int fidSize)
 
void defineParams ()
 Define parameters. More...
 
void run ()
 Run. More...
 
- Public Member Functions inherited from XmippProgram
const char * getParam (const char *param, int arg=0)
 
const char * getParam (const char *param, const char *subparam, int arg=0)
 
int getIntParam (const char *param, int arg=0)
 
int getIntParam (const char *param, const char *subparam, int arg=0)
 
double getDoubleParam (const char *param, int arg=0)
 
double getDoubleParam (const char *param, const char *subparam, int arg=0)
 
float getFloatParam (const char *param, int arg=0)
 
float getFloatParam (const char *param, const char *subparam, int arg=0)
 
void getListParam (const char *param, StringVector &list)
 
int getCountParam (const char *param)
 
bool checkParam (const char *param)
 
bool existsParam (const char *param)
 
void addParamsLine (const String &line)
 
void addParamsLine (const char *line)
 
ParamDefgetParamDef (const char *param) const
 
virtual void quit (int exit_code=0) const
 
virtual int tryRun ()
 
void initProgress (size_t total, size_t stepBin=60)
 
void setProgress (size_t value=0)
 
void endProgress ()
 
void processDefaultComment (const char *param, const char *left)
 
void setDefaultComment (const char *param, const char *comment)
 
virtual void initComments ()
 
void setProgramName (const char *name)
 
void addUsageLine (const char *line, bool verbatim=false)
 
void clearUsage ()
 
void addExampleLine (const char *example, bool verbatim=true)
 
void addSeeAlsoLine (const char *seeAlso)
 
void addKeywords (const char *keywords)
 
const char * name () const
 
virtual void usage (int verb=0) const
 
virtual void usage (const String &param, int verb=2)
 
int version () const
 
virtual void show () const
 
virtual void read (int argc, const char **argv, bool reportErrors=true)
 
virtual void read (int argc, char **argv, bool reportErrors=true)
 
void read (const String &argumentsLine)
 
 XmippProgram ()
 
 XmippProgram (int argc, const char **argv)
 
virtual ~XmippProgram ()
 

Public Attributes

FileName fnCoords
 
FileName fnVol
 
FileName fnFid
 
double maxTilt
 
double minTilt
 
double tiltStep
 
double sigmaNoise
 
double fidDiameter
 
FileName fnTsOut
 
FileName fnTomoOut
 
int xdim
 
int ydim
 
int nfids
 
int thickness
 
double sampling
 
- Public Attributes inherited from XmippProgram
bool doRun
 
bool runWithoutArgs
 
int verbose
 Verbosity level. More...
 
int debug
 

Additional Inherited Members

- Protected Member Functions inherited from XmippProgram
void defineCommons ()
 
- Protected Attributes inherited from XmippProgram
int errorCode
 
ProgramDefprogDef
 Program definition and arguments parser. More...
 
std::map< String, CommentListdefaultComments
 
int argc
 Original command line arguments. More...
 
const char ** argv
 

Detailed Description

Movie alignment correlation Parameters.

Definition at line 38 of file tomo_simulate_tilt_series.h.

Member Function Documentation

◆ createFiducial() [1/2]

void ProgTomoSimulateTiltseries::createFiducial ( MultidimArray< double > &  fidImage,
int  boxsize 
)

create fiducial

◆ createFiducial() [2/2]

void ProgTomoSimulateTiltseries::createFiducial ( MultidimArray< double > &  fidImage,
MultidimArray< double > &  fidVol,
int  fidSize 
)

Definition at line 74 of file tomo_simulate_tilt_series.cpp.

75 {
76  fidImage.initZeros(fidSize, fidSize);
77  fidVol.initZeros(fidSize, fidSize, fidSize);
78  auto halfbox = round(0.5*fidSize);
79  int fidSizeVoxels;
80 
81  auto fidSize2 = fidSize*fidSize;
82 
83  // We use 5*sigmaNoise to ensure the fiducial is visible with this noise level
84 
85  for (size_t i= 0; i<fidSize; i++)
86  {
87  auto i2 = (i-halfbox)*(i-halfbox);
88  for (size_t j= 0; j<fidSize; j++)
89  {
90  auto j2 = (j-halfbox)*(j-halfbox);
91 
92  if ((j2 + i2) < fidSize2)
93  A2D_ELEM(fidImage, i, j) = 5*sigmaNoise;
94  }
95  }
96 
97  for (size_t k= 0; k<fidSize; k++)
98  {
99  auto k2 = (k-halfbox)*(k-halfbox);
100  for (size_t i= 0; i<fidSize; i++)
101  {
102  auto i2 = k2 + (i-halfbox)*(i-halfbox);
103  for (size_t j= 0; j<fidSize; j++)
104  {
105  auto j2 = i2 + (j-halfbox)*(j-halfbox);
106 
107  if (i2 < fidSize2)
108  A3D_ELEM(fidVol, k, i, j) = 5*sigmaNoise;
109  }
110  }
111  }
112 
113 
114 }
#define A2D_ELEM(v, i, j)
#define i
ql0001_ & k(htemp+1),(cvec+1),(atemp+1),(bj+1),(bl+1),(bu+1),(x+1),(clamda+1), &iout, infoqp, &zero,(w+1), &lenw,(iw+1), &leniw, &glob_grd.epsmac
#define A3D_ELEM(V, k, i, j)
#define j
int round(double x)
Definition: ap.cpp:7245
void initZeros(const MultidimArray< T1 > &op)

◆ createSphere()

void ProgTomoSimulateTiltseries::createSphere ( MultidimArray< int > &  mask,
int  boxsize 
)

create a cirte to limit the projection extension

Definition at line 116 of file tomo_simulate_tilt_series.cpp.

117 {
118  int halfbox = round(0.5*boxsize);
119  auto halfbox2 =halfbox*halfbox;
120 
121  std::cout << "halfbox = " << halfbox << std::endl;
122 
123  size_t idx = 0;
124  long n=0;
125  for (int k= 0; k<boxsize; k++)
126  {
127  int k2 = (k-halfbox)*(k-halfbox);
128  std::cout << "k2 = " << k2 << std::endl;
129  for (int i= 0; i<boxsize; i++)
130  {
131  int i2 = (i-halfbox)*(i-halfbox);
132  int i2k2 = i2 + k2;
133  for (int j= 0; j<boxsize; j++)
134  {
135  int j2 = (j-halfbox)*(j-halfbox);
136 
137  const bool inside = i2k2+j2 <= halfbox2;
138  A3D_ELEM(mask, k, i, j) = static_cast<int>(inside);
139  n++;
140  }
141  }
142  }
143 }
#define i
ql0001_ & k(htemp+1),(cvec+1),(atemp+1),(bj+1),(bl+1),(bu+1),(x+1),(clamda+1), &iout, infoqp, &zero,(w+1), &lenw,(iw+1), &leniw, &glob_grd.epsmac
#define A3D_ELEM(V, k, i, j)
#define j
int round(double x)
Definition: ap.cpp:7245
int * n

◆ defineParams()

void ProgTomoSimulateTiltseries::defineParams ( )
virtual

Define parameters.

Reimplemented from XmippProgram.

Definition at line 54 of file tomo_simulate_tilt_series.cpp.

55 {
56  addUsageLine("This function takes a tomogram an extract a set of subtomogram from it. The coordinates of the subtomograms are speciffied in the metadata given by coordinates.");
57  addParamsLine(" --coordinates <xmd_file=\"\"> : Metadata (.xmd file) with the tilt series");
58  addParamsLine(" --vol <xmd_file=\"\"> : Volume (.mrc file) with the coordidanates to be extracted from the tomogram");
59  addParamsLine("[ --xdim <xdim=1000>] : Particle box size in voxels.");
60  addParamsLine("[ --ydim <ydim=1000> ] : Particle box size in voxels.");
61  addParamsLine("[ --minTilt <minTilt=-60.0>] : Minimum tilt angle");
62  addParamsLine("[ --maxTilt <maxTilt=60.0>] : Maximum tilt angle");
63  addParamsLine("[ --tiltStep <tiltStep=60.0>] : Step of the angular sampling. Distance between two consequtive tilt angles");
64  addParamsLine("[ --thickness <thickness=300>] : Tomogram thickness in pixel");
65  addParamsLine("[ --sampling <s=1>] : Sampling rate in (A).");
66  addParamsLine("[ --fiducialCoordinates <xmd_file=\"\">] : Metadata (.xmd file) with fiducial coordinates in the tomogram");
67  addParamsLine("[ --fiducialDiameter <xmd_file=\"\">] : Fiducial diameter in (A)");
68  addParamsLine("[ --sigmaNoise <sigmaNoise=-1>] : Standard deviation of the noise.");
69  addParamsLine(" --tiltseries <mrc_file=\"\"> : path to the output directory. ");
70  addParamsLine(" --tomogram <mrc_file=\"\"> : path to the output directory. ");
71 }
void addUsageLine(const char *line, bool verbatim=false)
void addParamsLine(const String &line)

◆ maskingRotatedSubtomo()

void ProgTomoSimulateTiltseries::maskingRotatedSubtomo ( MultidimArray< double > &  subtomo,
int  boxsize 
)

Definition at line 145 of file tomo_simulate_tilt_series.cpp.

146 {
147  //subtomo.resetOrigin();
148  auto halfbox = round(0.5*boxsize);
149  auto halfbox2 =halfbox*halfbox;
150 
151  std::cout << " boxsize = " << boxsize << " halfboxsize = " << halfbox << std::endl;
152 
153  long n=0;
154  for (size_t k= 0; k<boxsize; k++)
155  {
156  auto k2 = (k-halfbox)*(k-halfbox);
157  for (size_t j= 0; j<boxsize; j++)
158  {
159  auto j2 = k2+(j-halfbox)*(j-halfbox);
160  for (size_t i= 0; i<boxsize; i++)
161  {
162  auto i2 = (i-halfbox)*(i-halfbox);
163  if (i2+j2>halfbox2)
164  {
165  DIRECT_MULTIDIM_ELEM(subtomo, n) = 0.0;
166 
167  }
168  n++;
169  }
170  }
171  }
172 }
#define i
ql0001_ & k(htemp+1),(cvec+1),(atemp+1),(bj+1),(bl+1),(bu+1),(x+1),(clamda+1), &iout, infoqp, &zero,(w+1), &lenw,(iw+1), &leniw, &glob_grd.epsmac
#define DIRECT_MULTIDIM_ELEM(v, n)
#define j
int round(double x)
Definition: ap.cpp:7245
int * n

◆ placeSubtomoInTomo()

void ProgTomoSimulateTiltseries::placeSubtomoInTomo ( const MultidimArray< double > &  subtomo,
MultidimArray< double > &  tomo,
const int  xcoord,
const int  ycoord,
const int  zcood,
const size_t  halfboxsize 
)

Definition at line 175 of file tomo_simulate_tilt_series.cpp.

177 {
178  auto initzcoord = thickness/2 + zcoord-boxsize/2;
179  auto initxcoord = xdim/2 + xcoord-boxsize/2;
180  auto initycoord = ydim/2 + ycoord-boxsize/2;
181 
182  for (int k = initzcoord; k<(initzcoord+boxsize); k++)
183  {
184  for (int i = initycoord; i<(initycoord+boxsize); i++)
185  {
186  for (int j = initxcoord; j<(initxcoord+boxsize); j++)
187  {
188  DIRECT_A3D_ELEM(tomo, k, i, j) = -DIRECT_A3D_ELEM(subtomo, k-initzcoord, i-initycoord, j-initxcoord);
189  }
190  }
191  }
192 }
#define i
ql0001_ & k(htemp+1),(cvec+1),(atemp+1),(bj+1),(bl+1),(bu+1),(x+1),(clamda+1), &iout, infoqp, &zero,(w+1), &lenw,(iw+1), &leniw, &glob_grd.epsmac
#define DIRECT_A3D_ELEM(v, k, i, j)
#define j

◆ readParams()

void ProgTomoSimulateTiltseries::readParams ( )
virtual

Read argument from command line.

Reimplemented from XmippProgram.

Definition at line 35 of file tomo_simulate_tilt_series.cpp.

36 {
37  fnCoords = getParam("--coordinates");
38  fnVol = getParam("--vol");
39  xdim = getIntParam("--xdim");
40  ydim = getIntParam("--ydim");
41  minTilt = getDoubleParam("--minTilt");
42  maxTilt = getDoubleParam("--maxTilt");
43  tiltStep = getDoubleParam("--tiltStep");
44  thickness = getIntParam("--thickness");
45  sampling = getDoubleParam("--sampling");
46  fnFid = getParam("--fiducialCoordinates");
47  fidDiameter = getDoubleParam("--fiducialDiameter");
48  sigmaNoise = getDoubleParam("--sigmaNoise");
49  fnTsOut = getParam("--tiltseries");
50  fnTomoOut = getParam("--tomogram");
51 }
double getDoubleParam(const char *param, int arg=0)
const char * getParam(const char *param, int arg=0)
int getIntParam(const char *param, int arg=0)

◆ run()

void ProgTomoSimulateTiltseries::run ( )
virtual

Run.

Reimplemented from XmippProgram.

Definition at line 195 of file tomo_simulate_tilt_series.cpp.

196 {
197  std::cout << "Starting ... " << std::endl;
198 
199  // Reading the input map
200  Image<double> proteinImg;
201  auto &ptrVol = proteinImg();
202  proteinImg.read(fnVol);
203 
204  MultidimArray<double> rotatedVol; // This map is the rotated volume
205  rotatedVol.resizeNoCopy(ptrVol);
206 
207  // Defining input coordinates and subtomogram orientation
208  MetaDataVec mdCoords;
209  int xcoor, ycoor, zcoor;
210  double rot =0.0, tilt=0.0, psi=0, sx=0, sy=0;
211  Matrix2D<double> eulerMat_proj, eulerMat_VolRotation, eulerMat;
212  Projection imgPrj;
213 
214  MultidimArray<double> &ptrProj = imgPrj();
215 
216  int BSplinedegree = 3;
217  MultidimArray<double> fidImage;
218  MultidimArray<double> fidVol;
219 
220  if (fnFid != "")
221  {
222  int fidBoxsize;
223  fidBoxsize = round(fidDiameter/sampling);
224  createFiducial(fidImage, fidVol, fidBoxsize);
225  }
226 
227 
228  // Estimating the number of projections adn ouput tilt series
229  std::vector<double> tiltAngles;
230  Image<double> tiltseriesImg;
231  MultidimArray<double> &tiltseries = tiltseriesImg();
232  int numberOfProjections;
233  numberOfProjections = (maxTilt - minTilt)/tiltStep + 1;
234 
235  size_t boxsize, halfboxsize;
236  boxsize = XSIZE(ptrVol);
237  halfboxsize = round(0.5*boxsize);
238  tiltseries.initZeros(numberOfProjections, 1, ydim, xdim+2*boxsize);
239 
240  for (size_t idx = 0; idx<numberOfProjections; idx++)
241  {
242  tiltAngles.push_back(minTilt+idx*tiltStep);
243  }
244 
245  MultidimArray<int> mask;
246  mask.resizeNoCopy(ptrVol);
247 
248  // Reading the coordinates and generating tilt series, tomograms and coordinates.
249  MetaDataVec mdTiltSeries;
250  mdCoords.read(fnCoords);
251  MDRowVec row, rowOut;
252 
253  // This is the output tomogram
254  Image<double> tomogram;
255  auto &ptrTomo = tomogram();
256  ptrTomo.initZeros(1, thickness, ydim, xdim);
257 
258  std::cout << "Starting rows " << std::endl;
259  int addCoords = 0;
260 
261  for (const auto& row : mdCoords)
262  {
263  row.getValue(MDL_XCOOR, xcoor);
264  row.getValue(MDL_YCOOR, ycoor);
265  row.getValue(MDL_ZCOOR, zcoor);
266 
267  double theta, phi, xi;
268 
269 
270 
272  {
273 // row.getValue(MDL_ANGLE_ROT, theta);
274 // row.getValue(MDL_ANGLE_TILT, phi);
275 // row.getValue(MDL_ANGLE_PSI, xi);
276 
277  row.getValue(MDL_ANGLE_PSI, theta);
278  row.getValue(MDL_ANGLE_TILT, phi);
279  row.getValue(MDL_ANGLE_ROT, xi);
280 
281 // theta *= -1;
282 // phi *= -1;
283 // xi *= -1;
284  }
285  else
286  {
287  double u = (double) rand()/RAND_MAX;
288  double v = (double) rand()/RAND_MAX;
289  double w = (double) rand()/RAND_MAX;
290 
291  theta = 360.0*u;
292  phi = acos(2*v - 1.0)*180.0/PI;
293  xi = 360*w;
294 
295  //eulerMat_proj.initIdentity(4);
296  }
297 
298  Euler_angles2matrix(theta, phi, xi, eulerMat_VolRotation, true);
299 
300  applyGeometry(xmipp_transformation::BSPLINE3, rotatedVol, ptrVol, eulerMat_VolRotation, xmipp_transformation::IS_NOT_INV, true, 0.);
301  maskingRotatedSubtomo(rotatedVol, boxsize);
302 
303  rotatedVol.setXmippOrigin();
304  //CenterFFT(rotatedVol,true);
305  placeSubtomoInTomo(rotatedVol, ptrTomo, xcoor, ycoor, zcoor, boxsize);
306 
307 
308  auto projector = FourierProjector(rotatedVol, 2.0, 0.5, BSplinedegree);
309 
310  for (size_t idx = 0; idx<tiltAngles.size(); idx++)
311  {
312  double tiltProj = tiltAngles[idx];
313  if (addCoords<1)
314  {
315  rowOut.setValue(MDL_ANGLE_TILT, tiltProj);
316  FileName fnTi;
317  fnTi = formatString("%i@", idx+1);
318  rowOut.setValue(MDL_IMAGE, fnTi + fnTsOut);
319  mdTiltSeries.addRow(rowOut);
320  }
321 
322  projectVolume(projector, imgPrj, boxsize, boxsize, 0.0, tiltProj, 0.0);
323 
324  Matrix1D<double> shifts(2);
325  tiltProj *= PI/180.0;
326 
327  double ct = cos(tiltProj);
328  double st = sin(tiltProj);
329 
330 
331  // Projection
332  auto x_2d = (int) (xcoor * ct + zcoor* st);
333  auto y_2d = (int) (ycoor);
334 
335  y_2d = y_2d+0.5*ydim;
336  x_2d = x_2d+0.5*xdim;
337 
338  int xlim = x_2d + halfboxsize;
339  int ylim = y_2d + halfboxsize;
340 
341  int xinit = x_2d - halfboxsize;
342  int yinit = y_2d - halfboxsize;
343 
344  if ((xlim>xdim) || (ylim>ydim) || (xinit<0) || (yinit<0))
345  {
346  //std::cout << "Particle out of the tilt image" << std::endl;
347  continue;
348  }
349 
350  for (int i=0; i<boxsize; i++)
351  {
352  if (yinit+i<ydim)
353  {
354  for (int j=0; j<boxsize; j++)
355  {
356  if (xinit+j<xdim)
357  {
358  NZYX_ELEM(tiltseries, idx, 0, yinit+i, xinit+j) += DIRECT_A2D_ELEM(ptrProj, i, j);
359  }
360  }
361  }
362  }
363  }
364  addCoords++;
365  }
366 
367  MultidimArray<double> tiltseriesOut;
368  tiltseriesOut.initZeros(numberOfProjections, 1, ydim, xdim);
369 
370  if (sigmaNoise>0)
371  {
372  std::random_device rd{};
373  std::mt19937 gen{rd()};
374 
375  // values near the mean are the most likely
376  // standard deviation affects the dispersion of generated values from the mean
377  std::normal_distribution dts{0.0, sigmaNoise};
378  std::normal_distribution dtom{0.0, sigmaNoise/boxsize};
379 
380  // draw a sample from the normal distribution and round it to an integer
381  auto randomNumberTs = [&dts, &gen]{ return dts(gen); };
382  auto randomNumberTom = [&dtom, &gen]{ return dtom(gen); };
383 
384 
385  for (size_t idx = 0; idx<tiltAngles.size(); idx++)
386  {
387  for (int i=0; i<ydim; i++)
388  {
389  for (int j=0; j<xdim; j++)
390  {
391  NZYX_ELEM(tiltseriesOut, idx, 0, i, j) = -NZYX_ELEM(tiltseries, idx, 0, i, j)+randomNumberTs();
392  }
393  }
394  }
395 
397  {
398  DIRECT_MULTIDIM_ELEM(ptrTomo, n) += randomNumberTom();
399  }
400  }
401  else
402  {
403 
404  for (size_t idx = 0; idx<tiltAngles.size(); idx++)
405  {
406  for (int i=0; i<ydim; i++)
407  {
408  for (int j=0; j<xdim; j++)
409  {
410  NZYX_ELEM(tiltseriesOut, idx, 0, i, j) = -NZYX_ELEM(tiltseries, idx, 0, i, j);
411  }
412  }
413  }
414  }
415 
416  tiltseriesImg() = tiltseriesOut;
417  tiltseriesImg.write(fnTsOut);
418  FileName fnOutXmd;
419  fnOutXmd = fnTsOut.removeLastExtension() + ".xmd";
420  tomogram.write(fnTomoOut);
421  std::cout << fnOutXmd << std::endl;
422  mdTiltSeries.write(fnOutXmd);
423 }
double xi
Rotation angle of an image (double,degrees)
FileName removeLastExtension() const
void read(const FileName &inFile, const std::vector< MDLabel > *desiredLabels=nullptr, bool decomposeStack=true) override
void Euler_angles2matrix(T alpha, T beta, T gamma, Matrix2D< T > &A, bool homogeneous)
Definition: geometry.cpp:624
void resizeNoCopy(const MultidimArray< T1 > &v)
Tilting angle of an image (double,degrees)
void setValue(const MDObject &object) override
void applyGeometry(int SplineDegree, MultidimArray< std::complex< double > > &V2, const MultidimArray< std::complex< double > > &V1, const Matrix2D< double > &A, bool inv, bool wrap, std::complex< double > outside, MultidimArray< double > *BcoeffsPtr)
#define DIRECT_A2D_ELEM(v, i, j)
void write(const FileName &name="", size_t select_img=ALL_IMAGES, bool isStack=false, int mode=WRITE_OVERWRITE, CastWriteMode castMode=CW_CAST, int _swapWrite=0)
Special label to be used when gathering MDs in MpiMetadataPrograms.
doublereal * w
void write(const FileName &outFile, WriteModeMetaData mode=MD_OVERWRITE) const
bool containsLabel(MDLabel label) const override
#define i
size_t addRow(const MDRow &row) override
double theta
T & getValue(MDLabel label)
void createFiducial(MultidimArray< double > &fidImage, int boxsize)
create fiducial
X component (int)
#define XSIZE(v)
#define FOR_ALL_DIRECT_ELEMENTS_IN_MULTIDIMARRAY(v)
#define DIRECT_MULTIDIM_ELEM(v, n)
void projectVolume(FourierProjector &projector, Projection &P, int Ydim, int Xdim, double rot, double tilt, double psi, const MultidimArray< double > *ctf)
#define NZYX_ELEM(v, l, k, i, j)
#define j
Z component (int)
int round(double x)
Definition: ap.cpp:7245
double psi(const double x)
String formatString(const char *format,...)
doublereal * u
int read(const FileName &name, DataMode datamode=DATA, size_t select_img=ALL_IMAGES, bool mapData=false, int mode=WRITE_READONLY)
Y component (int)
void initZeros(const MultidimArray< T1 > &op)
#define PI
Definition: tools.h:43
void maskingRotatedSubtomo(MultidimArray< double > &subtomo, int boxsize)
void placeSubtomoInTomo(const MultidimArray< double > &subtomo, MultidimArray< double > &tomo, const int xcoord, const int ycoord, const int zcood, const size_t halfboxsize)
int * n
Name of an image (std::string)

Member Data Documentation

◆ fidDiameter

double ProgTomoSimulateTiltseries::fidDiameter

Fiducial size

Definition at line 53 of file tomo_simulate_tilt_series.h.

◆ fnCoords

FileName ProgTomoSimulateTiltseries::fnCoords

input filename of the metadata with coordinates

Definition at line 42 of file tomo_simulate_tilt_series.h.

◆ fnFid

FileName ProgTomoSimulateTiltseries::fnFid

Definition at line 47 of file tomo_simulate_tilt_series.h.

◆ fnTomoOut

FileName ProgTomoSimulateTiltseries::fnTomoOut

Definition at line 56 of file tomo_simulate_tilt_series.h.

◆ fnTsOut

FileName ProgTomoSimulateTiltseries::fnTsOut

output tilt series

Definition at line 56 of file tomo_simulate_tilt_series.h.

◆ fnVol

FileName ProgTomoSimulateTiltseries::fnVol

input filename with a volume of the protein

Definition at line 45 of file tomo_simulate_tilt_series.h.

◆ maxTilt

double ProgTomoSimulateTiltseries::maxTilt

Tilting parameters and std of noise

Definition at line 50 of file tomo_simulate_tilt_series.h.

◆ minTilt

double ProgTomoSimulateTiltseries::minTilt

Definition at line 50 of file tomo_simulate_tilt_series.h.

◆ nfids

int ProgTomoSimulateTiltseries::nfids

number of fiducials

Definition at line 63 of file tomo_simulate_tilt_series.h.

◆ sampling

double ProgTomoSimulateTiltseries::sampling

Sampling rate

Definition at line 69 of file tomo_simulate_tilt_series.h.

◆ sigmaNoise

double ProgTomoSimulateTiltseries::sigmaNoise

Definition at line 50 of file tomo_simulate_tilt_series.h.

◆ thickness

int ProgTomoSimulateTiltseries::thickness

Tomogram thickness

Definition at line 66 of file tomo_simulate_tilt_series.h.

◆ tiltStep

double ProgTomoSimulateTiltseries::tiltStep

Definition at line 50 of file tomo_simulate_tilt_series.h.

◆ xdim

int ProgTomoSimulateTiltseries::xdim

dimensions of the tilt series

Definition at line 59 of file tomo_simulate_tilt_series.h.

◆ ydim

int ProgTomoSimulateTiltseries::ydim

Definition at line 60 of file tomo_simulate_tilt_series.h.


The documentation for this class was generated from the following files: