summaryrefslogtreecommitdiffstats
path: root/cuda
diff options
context:
space:
mode:
authorWillem Jan Palenstijn <Willem.Jan.Palenstijn@cwi.nl>2019-04-06 18:01:16 +0200
committerWillem Jan Palenstijn <Willem.Jan.Palenstijn@cwi.nl>2019-09-25 14:10:10 +0200
commit609e81d67217f4ff21c8a0aec82584da0fee1908 (patch)
tree9dc3da429ea0963117eb8a41a390a37a289a784d /cuda
parent0c2482e1dce65ded6215cd5634d86b4c00381e27 (diff)
downloadastra-609e81d67217f4ff21c8a0aec82584da0fee1908.tar.gz
astra-609e81d67217f4ff21c8a0aec82584da0fee1908.tar.bz2
astra-609e81d67217f4ff21c8a0aec82584da0fee1908.tar.xz
astra-609e81d67217f4ff21c8a0aec82584da0fee1908.zip
Remove unmaintained, out of date 'STANDALONE' cuda code
Diffstat (limited to 'cuda')
-rw-r--r--cuda/2d/cgls.cu61
-rw-r--r--cuda/2d/em.cu65
-rw-r--r--cuda/2d/fan_bp.cu67
-rw-r--r--cuda/2d/fan_fp.cu85
-rw-r--r--cuda/2d/fft.cu207
-rw-r--r--cuda/2d/par_bp.cu56
-rw-r--r--cuda/2d/par_fp.cu66
-rw-r--r--cuda/2d/sirt.cu63
-rw-r--r--cuda/3d/cgls3d.cu162
-rw-r--r--cuda/3d/cone_bp.cu170
-rw-r--r--cuda/3d/cone_fp.cu106
-rw-r--r--cuda/3d/fdk.cu222
-rw-r--r--cuda/3d/par3d_bp.cu163
-rw-r--r--cuda/3d/par3d_fp.cu168
-rw-r--r--cuda/3d/sirt3d.cu161
15 files changed, 0 insertions, 1822 deletions
diff --git a/cuda/2d/cgls.cu b/cuda/2d/cgls.cu
index 905b960..e7238b9 100644
--- a/cuda/2d/cgls.cu
+++ b/cuda/2d/cgls.cu
@@ -29,10 +29,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
@@ -206,60 +202,3 @@ float CGLS::computeDiffNorm()
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_sinoData;
-
- SDimensions dims;
- dims.iVolWidth = 1024;
- dims.iVolHeight = 1024;
- dims.iProjAngles = 512;
- dims.iProjDets = 1536;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, sinoPitch;
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- zeroVolume(D_volumeData, volumePitch, dims.iVolWidth, dims.iVolHeight);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_sinoData, dims.iProjDets, dims.iProjAngles, sinoPitch);
- zeroVolume(D_sinoData, sinoPitch, dims.iProjDets, dims.iProjAngles);
- printf("pitch: %u\n", sinoPitch);
-
- unsigned int y, x;
- float* sino = loadImage("sino.png", y, x);
-
- float* img = new float[dims.iVolWidth*dims.iVolHeight];
-
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_sinoData, sinoPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- CGLS cgls;
-
- cgls.setGeometry(dims, angle);
- cgls.init();
-
- cgls.setBuffers(D_volumeData, volumePitch, D_sinoData, sinoPitch);
-
- cgls.iterate(25);
-
- delete[] angle;
-
- copyVolumeFromDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
-
- saveImage("vol.png",dims.iVolHeight,dims.iVolWidth,img);
-
- return 0;
-}
-#endif
diff --git a/cuda/2d/em.cu b/cuda/2d/em.cu
index aa272d8..df140ec 100644
--- a/cuda/2d/em.cu
+++ b/cuda/2d/em.cu
@@ -29,10 +29,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
@@ -168,64 +164,3 @@ float EM::computeDiffNorm()
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_sinoData;
-
- SDimensions dims;
- dims.iVolWidth = 1024;
- dims.iVolHeight = 1024;
- dims.iProjAngles = 512;
- dims.iProjDets = 1536;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, sinoPitch;
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- zeroVolume(D_volumeData, volumePitch, dims.iVolWidth, dims.iVolHeight);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_sinoData, dims.iProjDets, dims.iProjAngles, sinoPitch);
- zeroVolume(D_sinoData, sinoPitch, dims.iProjDets, dims.iProjAngles);
- printf("pitch: %u\n", sinoPitch);
-
- unsigned int y, x;
- float* sino = loadImage("sino.png", y, x);
-
- float* img = new float[dims.iVolWidth*dims.iVolHeight];
-
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_sinoData, sinoPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- EM em;
-
- em.setGeometry(dims, angle);
- em.init();
-
- // TODO: Initialize D_volumeData with an unfiltered backprojection
-
- em.setBuffers(D_volumeData, volumePitch, D_sinoData, sinoPitch);
-
- em.iterate(25);
-
-
- delete[] angle;
-
- copyVolumeFromDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
-
- saveImage("vol.png",dims.iVolHeight,dims.iVolWidth,img);
-
- return 0;
-}
-
-#endif
diff --git a/cuda/2d/fan_bp.cu b/cuda/2d/fan_bp.cu
index d9d993b..76d2fb9 100644
--- a/cuda/2d/fan_bp.cu
+++ b/cuda/2d/fan_bp.cu
@@ -28,10 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -438,66 +434,3 @@ bool FanBP_FBPWeighted(float* D_volumeData, unsigned int volumePitch,
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_projData;
-
- SDimensions dims;
- dims.iVolWidth = 128;
- dims.iVolHeight = 128;
- dims.iProjAngles = 180;
- dims.iProjDets = 256;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, projPitch;
-
- SFanProjection projs[180];
-
- projs[0].fSrcX = 0.0f;
- projs[0].fSrcY = 1536.0f;
- projs[0].fDetSX = 128.0f;
- projs[0].fDetSY = -512.0f;
- projs[0].fDetUX = -1.0f;
- projs[0].fDetUY = 0.0f;
-
-#define ROTATE0(name,i,alpha) do { projs[i].f##name##X = projs[0].f##name##X * cos(alpha) - projs[0].f##name##Y * sin(alpha); projs[i].f##name##Y = projs[0].f##name##X * sin(alpha) + projs[0].f##name##Y * cos(alpha); } while(0)
-
- for (int i = 1; i < 180; ++i) {
- ROTATE0(Src, i, i*2*M_PI/180);
- ROTATE0(DetS, i, i*2*M_PI/180);
- ROTATE0(DetU, i, i*2*M_PI/180);
- }
-
-#undef ROTATE0
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_projData, dims.iProjDets, dims.iProjAngles, projPitch);
- printf("pitch: %u\n", projPitch);
-
- unsigned int y, x;
- float* sino = loadImage("sino.png", y, x);
-
- float* img = new float[dims.iVolWidth*dims.iVolHeight];
-
- memset(img, 0, dims.iVolWidth*dims.iVolHeight*sizeof(float));
-
- copyVolumeToDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- FanBP(D_volumeData, volumePitch, D_projData, projPitch, dims, projs, 1.0f);
-
- copyVolumeFromDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
-
- saveImage("vol.png",dims.iVolHeight,dims.iVolWidth,img);
-
- return 0;
-}
-#endif
diff --git a/cuda/2d/fan_fp.cu b/cuda/2d/fan_fp.cu
index 3479650..60c02f8 100644
--- a/cuda/2d/fan_fp.cu
+++ b/cuda/2d/fan_fp.cu
@@ -28,10 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -308,84 +304,3 @@ bool FanFP(float* D_volumeData, unsigned int volumePitch,
}
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_projData;
-
- SDimensions dims;
- dims.iVolWidth = 128;
- dims.iVolHeight = 128;
- dims.iProjAngles = 180;
- dims.iProjDets = 256;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, projPitch;
-
- SFanProjection projs[180];
-
- projs[0].fSrcX = 0.0f;
- projs[0].fSrcY = 1536.0f;
- projs[0].fDetSX = 128.0f;
- projs[0].fDetSY = -512.0f;
- projs[0].fDetUX = -1.0f;
- projs[0].fDetUY = 0.0f;
-
-#define ROTATE0(name,i,alpha) do { projs[i].f##name##X = projs[0].f##name##X * cos(alpha) - projs[0].f##name##Y * sin(alpha); projs[i].f##name##Y = projs[0].f##name##X * sin(alpha) + projs[0].f##name##Y * cos(alpha); } while(0)
-
- for (int i = 1; i < 180; ++i) {
- ROTATE0(Src, i, i*2*M_PI/180);
- ROTATE0(DetS, i, i*2*M_PI/180);
- ROTATE0(DetU, i, i*2*M_PI/180);
- }
-
-#undef ROTATE0
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_projData, dims.iProjDets, dims.iProjAngles, projPitch);
- printf("pitch: %u\n", projPitch);
-
- unsigned int y, x;
- float* img = loadImage("phantom128.png", y, x);
-
- float* sino = new float[dims.iProjAngles * dims.iProjDets];
-
- memset(sino, 0, dims.iProjAngles * dims.iProjDets * sizeof(float));
-
- copyVolumeToDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- FanFP(D_volumeData, volumePitch, D_projData, projPitch, dims, projs, 1.0f);
-
- delete[] angle;
-
- copySinogramFromDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- float s = 0.0f;
- for (unsigned int y = 0; y < dims.iProjAngles; ++y)
- for (unsigned int x = 0; x < dims.iProjDets; ++x)
- s += sino[y*dims.iProjDets+x] * sino[y*dims.iProjDets+x];
- printf("cpu norm: %f\n", s);
-
- //zeroVolume(D_projData, projPitch, dims.iProjDets, dims.iProjAngles);
- s = dotProduct2D(D_projData, projPitch, dims.iProjDets, dims.iProjAngles);
- printf("gpu norm: %f\n", s);
-
- saveImage("sino.png",dims.iProjAngles,dims.iProjDets,sino);
-
-
- return 0;
-}
-#endif
diff --git a/cuda/2d/fft.cu b/cuda/2d/fft.cu
index 2e94b79..8361ad2 100644
--- a/cuda/2d/fft.cu
+++ b/cuda/2d/fft.cu
@@ -314,210 +314,3 @@ void genCuFFTFilter(const SFilterConfig &_cfg, int _iProjectionCount,
}
-
-
-#ifdef STANDALONE
-
-__global__ static void doubleFourierOutput_kernel(int _iProjectionCount,
- int _iDetectorCount,
- cufftComplex* _pFourierOutput)
-{
- int iIndex = threadIdx.x + blockIdx.x * blockDim.x;
- int iProjectionIndex = iIndex / _iDetectorCount;
- int iDetectorIndex = iIndex % _iDetectorCount;
-
- if(iProjectionIndex >= _iProjectionCount)
- {
- return;
- }
-
- if(iDetectorIndex <= (_iDetectorCount / 2))
- {
- return;
- }
-
- int iOtherDetectorIndex = _iDetectorCount - iDetectorIndex;
-
- _pFourierOutput[iProjectionIndex * _iDetectorCount + iDetectorIndex].x = _pFourierOutput[iProjectionIndex * _iDetectorCount + iOtherDetectorIndex].x;
- _pFourierOutput[iProjectionIndex * _iDetectorCount + iDetectorIndex].y = -_pFourierOutput[iProjectionIndex * _iDetectorCount + iOtherDetectorIndex].y;
-}
-
-static void doubleFourierOutput(int _iProjectionCount, int _iDetectorCount,
- cufftComplex * _pFourierOutput)
-{
- const int iBlockSize = 256;
- int iElementCount = _iProjectionCount * _iDetectorCount;
- int iBlockCount = (iElementCount + iBlockSize - 1) / iBlockSize;
-
- doubleFourierOutput_kernel<<< iBlockCount, iBlockSize >>>(_iProjectionCount,
- _iDetectorCount,
- _pFourierOutput);
- CHECK_ERROR("doubleFourierOutput_kernel failed");
-}
-
-
-
-static void writeToMatlabFile(const char * _fileName, const float * _pfData,
- int _iRowCount, int _iColumnCount)
-{
- std::ofstream out(_fileName);
-
- for(int iRowIndex = 0; iRowIndex < _iRowCount; iRowIndex++)
- {
- for(int iColumnIndex = 0; iColumnIndex < _iColumnCount; iColumnIndex++)
- {
- out << _pfData[iColumnIndex + iRowIndex * _iColumnCount] << " ";
- }
-
- out << std::endl;
- }
-}
-
-static void convertComplexToRealImg(const cufftComplex * _pComplex,
- int _iElementCount,
- float * _pfReal, float * _pfImaginary)
-{
- for(int iIndex = 0; iIndex < _iElementCount; iIndex++)
- {
- _pfReal[iIndex] = _pComplex[iIndex].x;
- _pfImaginary[iIndex] = _pComplex[iIndex].y;
- }
-}
-
-void testCudaFFT()
-{
- const int iProjectionCount = 2;
- const int iDetectorCount = 1024;
- const int iTotalElementCount = iProjectionCount * iDetectorCount;
-
- float * pfHostProj = new float[iTotalElementCount];
- memset(pfHostProj, 0, sizeof(float) * iTotalElementCount);
-
- for(int iProjectionIndex = 0; iProjectionIndex < iProjectionCount; iProjectionIndex++)
- {
- for(int iDetectorIndex = 0; iDetectorIndex < iDetectorCount; iDetectorIndex++)
- {
-// int
-
-// pfHostProj[iIndex] = (float)rand() / (float)RAND_MAX;
- }
- }
-
- writeToMatlabFile("proj.mat", pfHostProj, iProjectionCount, iDetectorCount);
-
- float * pfDevProj = NULL;
- SAFE_CALL(cudaMalloc((void **)&pfDevProj, sizeof(float) * iTotalElementCount));
- SAFE_CALL(cudaMemcpy(pfDevProj, pfHostProj, sizeof(float) * iTotalElementCount, cudaMemcpyHostToDevice));
-
- cufftComplex * pDevFourProj = NULL;
- SAFE_CALL(cudaMalloc((void **)&pDevFourProj, sizeof(cufftComplex) * iTotalElementCount));
-
- cufftHandle plan;
- cufftResult result;
-
- result = cufftPlan1d(&plan, iDetectorCount, CUFFT_R2C, iProjectionCount);
- if(result != CUFFT_SUCCESS)
- {
- ASTRA_ERROR("Failed to plan 1d r2c fft");
- }
-
- result = cufftExecR2C(plan, pfDevProj, pDevFourProj);
- if(result != CUFFT_SUCCESS)
- {
- ASTRA_ERROR("Failed to exec 1d r2c fft");
- }
-
- cufftDestroy(plan);
-
- doubleFourierOutput(iProjectionCount, iDetectorCount, pDevFourProj);
-
- cufftComplex * pHostFourProj = new cufftComplex[iTotalElementCount];
- SAFE_CALL(cudaMemcpy(pHostFourProj, pDevFourProj, sizeof(cufftComplex) * iTotalElementCount, cudaMemcpyDeviceToHost));
-
- float * pfHostFourProjReal = new float[iTotalElementCount];
- float * pfHostFourProjImaginary = new float[iTotalElementCount];
-
- convertComplexToRealImg(pHostFourProj, iTotalElementCount, pfHostFourProjReal, pfHostFourProjImaginary);
-
- writeToMatlabFile("proj_four_real.mat", pfHostFourProjReal, iProjectionCount, iDetectorCount);
- writeToMatlabFile("proj_four_imaginary.mat", pfHostFourProjImaginary, iProjectionCount, iDetectorCount);
-
- float * pfDevInFourProj = NULL;
- SAFE_CALL(cudaMalloc((void **)&pfDevInFourProj, sizeof(float) * iTotalElementCount));
-
- result = cufftPlan1d(&plan, iDetectorCount, CUFFT_C2R, iProjectionCount);
- if(result != CUFFT_SUCCESS)
- {
- ASTRA_ERROR("Failed to plan 1d c2r fft");
- }
-
- result = cufftExecC2R(plan, pDevFourProj, pfDevInFourProj);
- if(result != CUFFT_SUCCESS)
- {
- ASTRA_ERROR("Failed to exec 1d c2r fft");
- }
-
- cufftDestroy(plan);
-
- rescaleInverseFourier(iProjectionCount, iDetectorCount, pfDevInFourProj);
-
- float * pfHostInFourProj = new float[iTotalElementCount];
- SAFE_CALL(cudaMemcpy(pfHostInFourProj, pfDevInFourProj, sizeof(float) * iTotalElementCount, cudaMemcpyDeviceToHost));
-
- writeToMatlabFile("in_four.mat", pfHostInFourProj, iProjectionCount, iDetectorCount);
-
- SAFE_CALL(cudaFree(pDevFourProj));
- SAFE_CALL(cudaFree(pfDevProj));
-
- delete [] pfHostInFourProj;
- delete [] pfHostFourProjReal;
- delete [] pfHostFourProjImaginary;
- delete [] pfHostProj;
- delete [] pHostFourProj;
-}
-
-void downloadDebugFilterComplex(float * _pfHostSinogram, int _iProjectionCount,
- int _iDetectorCount,
- cufftComplex * _pDevFilter,
- int _iFilterDetCount)
-{
- cufftComplex * pHostFilter = NULL;
- size_t complMemSize = sizeof(cufftComplex) * _iFilterDetCount * _iProjectionCount;
- pHostFilter = (cufftComplex *)malloc(complMemSize);
- SAFE_CALL(cudaMemcpy(pHostFilter, _pDevFilter, complMemSize, cudaMemcpyDeviceToHost));
-
- for(int iTargetProjIndex = 0; iTargetProjIndex < _iProjectionCount; iTargetProjIndex++)
- {
- for(int iTargetDetIndex = 0; iTargetDetIndex < min(_iDetectorCount, _iFilterDetCount); iTargetDetIndex++)
- {
- cufftComplex source = pHostFilter[iTargetDetIndex + iTargetProjIndex * _iFilterDetCount];
- float fReadValue = sqrtf(source.x * source.x + source.y * source.y);
- _pfHostSinogram[iTargetDetIndex + iTargetProjIndex * _iDetectorCount] = fReadValue;
- }
- }
-
- free(pHostFilter);
-}
-
-void downloadDebugFilterReal(float * _pfHostSinogram, int _iProjectionCount,
- int _iDetectorCount, float * _pfDevFilter,
- int _iFilterDetCount)
-{
- float * pfHostFilter = NULL;
- size_t memSize = sizeof(float) * _iFilterDetCount * _iProjectionCount;
- pfHostFilter = (float *)malloc(memSize);
- SAFE_CALL(cudaMemcpy(pfHostFilter, _pfDevFilter, memSize, cudaMemcpyDeviceToHost));
-
- for(int iTargetProjIndex = 0; iTargetProjIndex < _iProjectionCount; iTargetProjIndex++)
- {
- for(int iTargetDetIndex = 0; iTargetDetIndex < min(_iDetectorCount, _iFilterDetCount); iTargetDetIndex++)
- {
- float fSource = pfHostFilter[iTargetDetIndex + iTargetProjIndex * _iFilterDetCount];
- _pfHostSinogram[iTargetDetIndex + iTargetProjIndex * _iDetectorCount] = fSource;
- }
- }
-
- free(pfHostFilter);
-}
-
-#endif
diff --git a/cuda/2d/par_bp.cu b/cuda/2d/par_bp.cu
index 3bf78ee..f080abb 100644
--- a/cuda/2d/par_bp.cu
+++ b/cuda/2d/par_bp.cu
@@ -28,10 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -297,55 +293,3 @@ bool BP_SART(float* D_volumeData, unsigned int volumePitch,
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_projData;
-
- SDimensions dims;
- dims.iVolWidth = 1024;
- dims.iVolHeight = 1024;
- dims.iProjAngles = 512;
- dims.iProjDets = 1536;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
-
- unsigned int volumePitch, projPitch;
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_projData, dims.iProjDets, dims.iProjAngles, projPitch);
- printf("pitch: %u\n", projPitch);
-
- unsigned int y, x;
- float* sino = loadImage("sino.png", y, x);
-
- float* img = new float[dims.iVolWidth*dims.iVolHeight];
-
- memset(img, 0, dims.iVolWidth*dims.iVolHeight*sizeof(float));
-
- copyVolumeToDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- BP(D_volumeData, volumePitch, D_projData, projPitch, dims, angle, 0, 1.0f);
-
- delete[] angle;
-
- copyVolumeFromDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
-
- saveImage("vol.png",dims.iVolHeight,dims.iVolWidth,img);
-
- return 0;
-}
-#endif
diff --git a/cuda/2d/par_fp.cu b/cuda/2d/par_fp.cu
index e03381c..ea436c3 100644
--- a/cuda/2d/par_fp.cu
+++ b/cuda/2d/par_fp.cu
@@ -28,10 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -373,65 +369,3 @@ bool FP(float* D_volumeData, unsigned int volumePitch,
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_projData;
-
- SDimensions dims;
- dims.iVolWidth = 1024;
- dims.iVolHeight = 1024;
- dims.iProjAngles = 512;
- dims.iProjDets = 1536;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, projPitch;
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_projData, dims.iProjDets, dims.iProjAngles, projPitch);
- printf("pitch: %u\n", projPitch);
-
- unsigned int y, x;
- float* img = loadImage("phantom.png", y, x);
-
- float* sino = new float[dims.iProjAngles * dims.iProjDets];
-
- memset(sino, 0, dims.iProjAngles * dims.iProjDets * sizeof(float));
-
- copyVolumeToDevice(img, dims.iVolWidth, dims.iVolWidth, dims.iVolHeight, D_volumeData, volumePitch);
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- FP(D_volumeData, volumePitch, D_projData, projPitch, dims, angle, 0, 1.0f);
-
- delete[] angle;
-
- copySinogramFromDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_projData, projPitch);
-
- float s = 0.0f;
- for (unsigned int y = 0; y < dims.iProjAngles; ++y)
- for (unsigned int x = 0; x < dims.iProjDets; ++x)
- s += sino[y*dims.iProjDets+x] * sino[y*dims.iProjDets+x];
- printf("cpu norm: %f\n", s);
-
- //zeroVolume(D_projData, projPitch, dims.iProjDets, dims.iProjAngles);
- s = dotProduct2D(D_projData, projPitch, dims.iProjDets, dims.iProjAngles, 1, 0);
- printf("gpu norm: %f\n", s);
-
- saveImage("sino.png",dims.iProjAngles,dims.iProjDets,sino);
-
-
- return 0;
-}
-#endif
diff --git a/cuda/2d/sirt.cu b/cuda/2d/sirt.cu
index 2621490..2c5fdc9 100644
--- a/cuda/2d/sirt.cu
+++ b/cuda/2d/sirt.cu
@@ -29,10 +29,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/util.h"
#include "astra/cuda/2d/arith.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
@@ -302,62 +298,3 @@ float SIRT::computeDiffNorm()
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA;
-
-int main()
-{
- float* D_volumeData;
- float* D_sinoData;
-
- SDimensions dims;
- dims.iVolWidth = 1024;
- dims.iVolHeight = 1024;
- dims.iProjAngles = 512;
- dims.iProjDets = 1536;
- dims.fDetScale = 1.0f;
- dims.iRaysPerDet = 1;
- unsigned int volumePitch, sinoPitch;
-
- allocateVolume(D_volumeData, dims.iVolWidth, dims.iVolHeight, volumePitch);
- zeroVolume(D_volumeData, volumePitch, dims.iVolWidth, dims.iVolHeight);
- printf("pitch: %u\n", volumePitch);
-
- allocateVolume(D_sinoData, dims.iProjDets, dims.iProjAngles, sinoPitch);
- zeroVolume(D_sinoData, sinoPitch, dims.iProjDets, dims.iProjAngles);
- printf("pitch: %u\n", sinoPitch);
-
- unsigned int y, x;
- float* sino = loadImage("sino.png", y, x);
-
- float* img = new float[dims.iVolWidth*dims.iVolHeight];
-
- copySinogramToDevice(sino, dims.iProjDets, dims.iProjDets, dims.iProjAngles, D_sinoData, sinoPitch);
-
- float* angle = new float[dims.iProjAngles];
-
- for (unsigned int i = 0; i < dims.iProjAngles; ++i)
- angle[i] = i*(M_PI/dims.iProjAngles);
-
- SIRT sirt;
-
- sirt.setGeometry(dims, angle);
- sirt.init();
-
- sirt.setBuffers(D_volumeData, volumePitch, D_sinoData, sinoPitch);
-
- sirt.iterate(25);
-
-
- delete[] angle;
-
- copyVolumeFromDevice(img, dims.iVolWidth, dims, D_volumeData, volumePitch);
-
- saveImage("vol.png",dims.iVolHeight,dims.iVolWidth,img);
-
- return 0;
-}
-#endif
-
diff --git a/cuda/3d/cgls3d.cu b/cuda/3d/cgls3d.cu
index 10c5f1e..4829574 100644
--- a/cuda/3d/cgls3d.cu
+++ b/cuda/3d/cgls3d.cu
@@ -33,10 +33,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include <cstdio>
#include <cassert>
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
namespace astraCUDA3d {
CGLS::CGLS() : ReconAlgo3D()
@@ -263,161 +259,3 @@ bool doCGLS(cudaPitchedPtr& D_volumeData,
}
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA3d;
-
-int main()
-{
- SDimensions3D dims;
- dims.iVolX = 256;
- dims.iVolY = 256;
- dims.iVolZ = 256;
- dims.iProjAngles = 100;
- dims.iProjU = 512;
- dims.iProjV = 512;
- dims.iRaysPerDet = 1;
-
- SConeProjection angle[100];
- angle[0].fSrcX = -2905.6;
- angle[0].fSrcY = 0;
- angle[0].fSrcZ = 0;
-
- angle[0].fDetSX = 694.4;
- angle[0].fDetSY = -122.4704;
- angle[0].fDetSZ = -122.4704;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = .4784;
- //angle[0].fDetUY = .5;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = .4784;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 100; ++i) {
- angle[i] = angle[0];
- ROTATE0(Src, i, i*2*M_PI/100);
- ROTATE0(DetS, i, i*2*M_PI/100);
- ROTATE0(DetU, i, i*2*M_PI/100);
- ROTATE0(DetV, i, i*2*M_PI/100);
- }
-#undef ROTATE0
-
-
- cudaPitchedPtr volData = allocateVolumeData(dims);
- cudaPitchedPtr projData = allocateProjectionData(dims);
- zeroProjectionData(projData, dims);
-
- float* pbuf = new float[100*512*512];
- copyProjectionsFromDevice(pbuf, projData, dims);
- copyProjectionsToDevice(pbuf, projData, dims);
- delete[] pbuf;
-
-#if 0
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256; ++i) {
- for (unsigned int y = 0; y < 256; ++y)
- for (unsigned int x = 0; x < 256; ++x)
- slice[y*256+x] = (i-127.5)*(i-127.5)+(y-127.5)*(y-127.5)+(x-127.5)*(x-127.5) < 4900 ? 1.0f : 0.0f;
-
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
- }
- astraCUDA3d::ConeFP(volData, projData, dims, angle, 1.0f);
-
-#else
-
- for (int i = 0; i < 100; ++i) {
- char fname[32];
- sprintf(fname, "Tiffs/%04d.png", 4*i);
- unsigned int w,h;
- float* bufp = loadImage(fname, w,h);
-
- for (int j = 0; j < 512*512; ++j) {
- float v = bufp[j];
- if (v > 236.0f) v = 236.0f;
- v = logf(236.0f / v);
- bufp[j] = 256*v;
- }
-
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(((float*)projData.ptr)+100*512*j+512*i, bufp+512*j, 512*sizeof(float), cudaMemcpyHostToDevice);
- }
-
- delete[] bufp;
-
- }
-#endif
-
-#if 0
- float* bufs = new float[100*512];
-
- for (int i = 0; i < 512; ++i) {
- cudaMemcpy(bufs, ((float*)projData.ptr)+100*512*i, 100*512*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", projData.pitch, projData.xsize, projData.ysize);
-
- char fname[20];
- sprintf(fname, "sino%03d.png", i);
- saveImage(fname, 100, 512, bufs);
- }
-
- float* bufp = new float[512*512];
-
- for (int i = 0; i < 100; ++i) {
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(bufp+512*j, ((float*)projData.ptr)+100*512*j+512*i, 512*sizeof(float), cudaMemcpyDeviceToHost);
- }
-
- char fname[20];
- sprintf(fname, "proj%03d.png", i);
- saveImage(fname, 512, 512, bufp);
- }
-#endif
-
- zeroVolumeData(volData, dims);
-
- cudaPitchedPtr maskData;
- maskData.ptr = 0;
-
- astraCUDA3d::doCGLS(volData, projData, maskData, dims, angle, 50);
-#if 1
- float* buf = new float[256*256];
-
- for (int i = 0; i < 256; ++i) {
- cudaMemcpy(buf, ((float*)volData.ptr)+256*256*i, 256*256*sizeof(float), cudaMemcpyDeviceToHost);
-
- char fname[20];
- sprintf(fname, "vol%03d.png", i);
- saveImage(fname, 256, 256, buf);
- }
-#endif
-
- return 0;
-}
-#endif
-
diff --git a/cuda/3d/cone_bp.cu b/cuda/3d/cone_bp.cu
index 024c791..6b2c8a1 100644
--- a/cuda/3d/cone_bp.cu
+++ b/cuda/3d/cone_bp.cu
@@ -28,11 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/3d/util3d.h"
#include "astra/cuda/3d/dims3d.h"
-#ifdef STANDALONE
-#include "astra/cuda/3d/cone_fp.h"
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -380,168 +375,3 @@ bool ConeBP(cudaPitchedPtr D_volumeData,
}
-
-#ifdef STANDALONE
-int main()
-{
- astraCUDA3d::SDimensions3D dims;
- dims.iVolX = 512;
- dims.iVolY = 512;
- dims.iVolZ = 512;
- dims.iProjAngles = 496;
- dims.iProjU = 512;
- dims.iProjV = 512;
- dims.iRaysPerDetDim = 1;
- dims.iRaysPerVoxelDim = 1;
-
- cudaExtent extentV;
- extentV.width = dims.iVolX*sizeof(float);
- extentV.height = dims.iVolY;
- extentV.depth = dims.iVolZ;
-
- cudaPitchedPtr volData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&volData, extentV);
-
- cudaExtent extentP;
- extentP.width = dims.iProjU*sizeof(float);
- extentP.height = dims.iProjAngles;
- extentP.depth = dims.iProjV;
-
- cudaPitchedPtr projData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&projData, extentP);
- cudaMemset3D(projData, 0, extentP);
-
-#if 0
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 1.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
-#if 0
- if (i == 128) {
- for (unsigned int j = 0; j < 256*256; ++j)
- slice[j] = 0.0f;
- }
-#endif
- }
-#endif
-
-
- astraCUDA3d::SConeProjection angle[512];
- angle[0].fSrcX = -5120;
- angle[0].fSrcY = 0;
- angle[0].fSrcZ = 0;
-
- angle[0].fDetSX = 512;
- angle[0].fDetSY = -256;
- angle[0].fDetSZ = -256;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = 1;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = 1;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 512; ++i) {
- angle[i] = angle[0];
- ROTATE0(Src, i, i*2*M_PI/512);
- ROTATE0(DetS, i, i*2*M_PI/512);
- ROTATE0(DetU, i, i*2*M_PI/512);
- ROTATE0(DetV, i, i*2*M_PI/512);
- }
-#undef ROTATE0
-
-#if 0
- astraCUDA3d::ConeFP(volData, projData, dims, angle, 1.0f);
-#endif
-#if 0
- float* bufs = new float[180*512];
-
- for (int i = 0; i < 512; ++i) {
- cudaMemcpy(bufs, ((float*)projData.ptr)+180*512*i, 180*512*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", projData.pitch, projData.xsize, projData.ysize);
-
- char fname[20];
- sprintf(fname, "sino%03d.png", i);
- saveImage(fname, 180, 512, bufs);
- }
-
- float* bufp = new float[512*512];
-
- for (int i = 0; i < 180; ++i) {
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(bufp+512*j, ((float*)projData.ptr)+180*512*j+512*i, 512*sizeof(float), cudaMemcpyDeviceToHost);
- }
-
- char fname[20];
- sprintf(fname, "proj%03d.png", i);
- saveImage(fname, 512, 512, bufp);
- }
-#endif
-#if 0
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 0.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
- }
-#endif
-
- astraCUDA3d::ConeBP(volData, projData, dims, angle, 1.0f);
-#if 0
- float* buf = new float[256*256];
-
- for (int i = 0; i < 256; ++i) {
- cudaMemcpy(buf, ((float*)volData.ptr)+256*256*i, 256*256*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", volData.pitch, volData.xsize, volData.ysize);
-
- char fname[20];
- sprintf(fname, "vol%03d.png", i);
- saveImage(fname, 256, 256, buf);
- }
-#endif
-
-}
-#endif
diff --git a/cuda/3d/cone_fp.cu b/cuda/3d/cone_fp.cu
index 418f8fd..bd607fa 100644
--- a/cuda/3d/cone_fp.cu
+++ b/cuda/3d/cone_fp.cu
@@ -28,10 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/3d/util3d.h"
#include "astra/cuda/3d/dims3d.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -498,105 +494,3 @@ bool ConeFP(cudaPitchedPtr D_volumeData,
}
-
-#ifdef STANDALONE
-int main()
-{
- SDimensions3D dims;
- dims.iVolX = 256;
- dims.iVolY = 256;
- dims.iVolZ = 256;
- dims.iProjAngles = 32;
- dims.iProjU = 512;
- dims.iProjV = 512;
- dims.iRaysPerDet = 1;
-
- cudaExtent extentV;
- extentV.width = dims.iVolX*sizeof(float);
- extentV.height = dims.iVolY;
- extentV.depth = dims.iVolZ;
-
- cudaPitchedPtr volData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&volData, extentV);
-
- cudaExtent extentP;
- extentP.width = dims.iProjU*sizeof(float);
- extentP.height = dims.iProjV;
- extentP.depth = dims.iProjAngles;
-
- cudaPitchedPtr projData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&projData, extentP);
- cudaMemset3D(projData, 0, extentP);
-
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 1.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaError err = cudaMemcpy3D(&p);
- assert(!err);
- }
-
-
- SConeProjection angle[32];
- angle[0].fSrcX = -1536;
- angle[0].fSrcY = 0;
- angle[0].fSrcZ = 200;
-
- angle[0].fDetSX = 512;
- angle[0].fDetSY = -256;
- angle[0].fDetSZ = -256;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = 1;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = 1;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 32; ++i) {
- angle[i] = angle[0];
- ROTATE0(Src, i, i*1*M_PI/180);
- ROTATE0(DetS, i, i*1*M_PI/180);
- ROTATE0(DetU, i, i*1*M_PI/180);
- ROTATE0(DetV, i, i*1*M_PI/180);
- }
-#undef ROTATE0
-
- astraCUDA3d::ConeFP(volData, projData, dims, angle, 1.0f);
-
- float* buf = new float[512*512];
-
- cudaMemcpy(buf, ((float*)projData.ptr)+512*512*8, 512*512*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", projData.pitch, projData.xsize, projData.ysize);
-
- saveImage("proj.png", 512, 512, buf);
-
-
-}
-#endif
diff --git a/cuda/3d/fdk.cu b/cuda/3d/fdk.cu
index af95b6b..456694f 100644
--- a/cuda/3d/fdk.cu
+++ b/cuda/3d/fdk.cu
@@ -32,11 +32,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/2d/fft.h"
-#ifdef STANDALONE
-#include "astra/cuda/3d/cone_fp.h"
-#include "testutil.h"
-#endif
-
#include "astra/Logging.h"
#include <cstdio>
@@ -377,220 +372,3 @@ bool FDK(cudaPitchedPtr D_volumeData,
}
-
-#ifdef STANDALONE
-void dumpVolume(const char* filespec, const cudaPitchedPtr& data, const SDimensions3D& dims, float fMin, float fMax)
-{
- float* buf = new float[dims.iVolX*dims.iVolY];
- unsigned int pitch = data.pitch / sizeof(float);
-
- for (int i = 0; i < dims.iVolZ; ++i) {
- cudaMemcpy2D(buf, dims.iVolX*sizeof(float), ((float*)data.ptr)+pitch*dims.iVolY*i, data.pitch, dims.iVolX*sizeof(float), dims.iVolY, cudaMemcpyDeviceToHost);
-
- char fname[512];
- sprintf(fname, filespec, dims.iVolZ-i-1);
- saveImage(fname, dims.iVolY, dims.iVolX, buf, fMin, fMax);
- }
-}
-
-void dumpSinograms(const char* filespec, const cudaPitchedPtr& data, const SDimensions3D& dims, float fMin, float fMax)
-{
- float* bufs = new float[dims.iProjAngles*dims.iProjU];
- unsigned int pitch = data.pitch / sizeof(float);
-
- for (int i = 0; i < dims.iProjV; ++i) {
- cudaMemcpy2D(bufs, dims.iProjU*sizeof(float), ((float*)data.ptr)+pitch*dims.iProjAngles*i, data.pitch, dims.iProjU*sizeof(float), dims.iProjAngles, cudaMemcpyDeviceToHost);
-
- char fname[512];
- sprintf(fname, filespec, i);
- saveImage(fname, dims.iProjAngles, dims.iProjU, bufs, fMin, fMax);
- }
-}
-
-void dumpProjections(const char* filespec, const cudaPitchedPtr& data, const SDimensions3D& dims, float fMin, float fMax)
-{
- float* bufp = new float[dims.iProjV*dims.iProjU];
- unsigned int pitch = data.pitch / sizeof(float);
-
- for (int i = 0; i < dims.iProjAngles; ++i) {
- for (int j = 0; j < dims.iProjV; ++j) {
- cudaMemcpy(bufp+dims.iProjU*j, ((float*)data.ptr)+pitch*dims.iProjAngles*j+pitch*i, dims.iProjU*sizeof(float), cudaMemcpyDeviceToHost);
- }
-
- char fname[512];
- sprintf(fname, filespec, i);
- saveImage(fname, dims.iProjV, dims.iProjU, bufp, fMin, fMax);
- }
-}
-
-
-
-
-int main()
-{
-#if 0
- SDimensions3D dims;
- dims.iVolX = 512;
- dims.iVolY = 512;
- dims.iVolZ = 512;
- dims.iProjAngles = 180;
- dims.iProjU = 1024;
- dims.iProjV = 1024;
- dims.iRaysPerDet = 1;
-
- cudaExtent extentV;
- extentV.width = dims.iVolX*sizeof(float);
- extentV.height = dims.iVolY;
- extentV.depth = dims.iVolZ;
-
- cudaPitchedPtr volData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&volData, extentV);
-
- cudaExtent extentP;
- extentP.width = dims.iProjU*sizeof(float);
- extentP.height = dims.iProjAngles;
- extentP.depth = dims.iProjV;
-
- cudaPitchedPtr projData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&projData, extentP);
- cudaMemset3D(projData, 0, extentP);
-
-#if 0
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 1.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
-#if 0
- if (i == 128) {
- for (unsigned int j = 0; j < 256*256; ++j)
- slice[j] = 0.0f;
- }
-#endif
- }
-#endif
-
- SConeProjection angle[180];
- angle[0].fSrcX = -1536;
- angle[0].fSrcY = 0;
- angle[0].fSrcZ = 0;
-
- angle[0].fDetSX = 1024;
- angle[0].fDetSY = -512;
- angle[0].fDetSZ = 512;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = 1;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = -1;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 180; ++i) {
- angle[i] = angle[0];
- ROTATE0(Src, i, i*2*M_PI/180);
- ROTATE0(DetS, i, i*2*M_PI/180);
- ROTATE0(DetU, i, i*2*M_PI/180);
- ROTATE0(DetV, i, i*2*M_PI/180);
- }
-#undef ROTATE0
-
- astraCUDA3d::ConeFP(volData, projData, dims, angle, 1.0f);
-
- //dumpSinograms("sino%03d.png", projData, dims, 0, 512);
- //dumpProjections("proj%03d.png", projData, dims, 0, 512);
-
- astraCUDA3d::zeroVolumeData(volData, dims);
-
- float* angles = new float[dims.iProjAngles];
- for (int i = 0; i < 180; ++i)
- angles[i] = i*2*M_PI/180;
-
- astraCUDA3d::FDK(volData, projData, 1536, 512, 0, 0, dims, angles);
-
- dumpVolume("vol%03d.png", volData, dims, -20, 100);
-
-
-#else
-
- SDimensions3D dims;
- dims.iVolX = 1000;
- dims.iVolY = 999;
- dims.iVolZ = 500;
- dims.iProjAngles = 376;
- dims.iProjU = 1024;
- dims.iProjV = 524;
- dims.iRaysPerDet = 1;
-
- float* angles = new float[dims.iProjAngles];
- for (int i = 0; i < dims.iProjAngles; ++i)
- angles[i] = -i*(M_PI)/360;
-
- cudaPitchedPtr volData = astraCUDA3d::allocateVolumeData(dims);
- cudaPitchedPtr projData = astraCUDA3d::allocateProjectionData(dims);
- astraCUDA3d::zeroProjectionData(projData, dims);
- astraCUDA3d::zeroVolumeData(volData, dims);
-
- timeval t;
- tic(t);
-
- for (int i = 0; i < dims.iProjAngles; ++i) {
- char fname[256];
- sprintf(fname, "/home/wpalenst/tmp/Elke/proj%04d.png", i);
- unsigned int w,h;
- float* bufp = loadImage(fname, w,h);
-
- int pitch = projData.pitch / sizeof(float);
- for (int j = 0; j < dims.iProjV; ++j) {
- cudaMemcpy(((float*)projData.ptr)+dims.iProjAngles*pitch*j+pitch*i, bufp+dims.iProjU*j, dims.iProjU*sizeof(float), cudaMemcpyHostToDevice);
- }
-
- delete[] bufp;
- }
- printf("Load time: %f\n", toc(t));
-
- //dumpSinograms("sino%03d.png", projData, dims, -8.0f, 256.0f);
- //astraCUDA3d::FDK(volData, projData, 7350, 62355, 0, 10, dims, angles);
- //astraCUDA3d::FDK(volData, projData, 7350, -380, 0, 10, dims, angles);
-
- tic(t);
-
- astraCUDA3d::FDK(volData, projData, 7383.29867, 0, 0, 10, dims, angles);
-
- printf("FDK time: %f\n", toc(t));
- tic(t);
-
- dumpVolume("vol%03d.png", volData, dims, -65.9f, 200.0f);
- //dumpVolume("vol%03d.png", volData, dims, 0.0f, 256.0f);
- printf("Save time: %f\n", toc(t));
-
-#endif
-
-
-}
-#endif
diff --git a/cuda/3d/par3d_bp.cu b/cuda/3d/par3d_bp.cu
index 3673fa8..602f209 100644
--- a/cuda/3d/par3d_bp.cu
+++ b/cuda/3d/par3d_bp.cu
@@ -28,11 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/3d/util3d.h"
#include "astra/cuda/3d/dims3d.h"
-#ifdef STANDALONE
-#include "astra/cuda/3d/par3d_fp.h"
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -317,161 +312,3 @@ bool Par3DBP(cudaPitchedPtr D_volumeData,
}
-
-#ifdef STANDALONE
-int main()
-{
- SDimensions3D dims;
- dims.iVolX = 256;
- dims.iVolY = 256;
- dims.iVolZ = 256;
- dims.iProjAngles = 180;
- dims.iProjU = 512;
- dims.iProjV = 512;
- dims.iRaysPerDet = 1;
-
- cudaExtent extentV;
- extentV.width = dims.iVolX*sizeof(float);
- extentV.height = dims.iVolY;
- extentV.depth = dims.iVolZ;
-
- cudaPitchedPtr volData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&volData, extentV);
-
- cudaExtent extentP;
- extentP.width = dims.iProjU*sizeof(float);
- extentP.height = dims.iProjAngles;
- extentP.depth = dims.iProjV;
-
- cudaPitchedPtr projData; // pitch, ptr, xsize, ysize
-
- cudaMalloc3D(&projData, extentP);
- cudaMemset3D(projData, 0, extentP);
-
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 1.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
-#if 0
- if (i == 128) {
- for (unsigned int j = 0; j < 256*256; ++j)
- slice[j] = 0.0f;
- }
-#endif
- }
-
-
- SPar3DProjection angle[180];
- angle[0].fRayX = 1;
- angle[0].fRayY = 0;
- angle[0].fRayZ = 0;
-
- angle[0].fDetSX = 512;
- angle[0].fDetSY = -256;
- angle[0].fDetSZ = -256;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = 1;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = 1;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 180; ++i) {
- angle[i] = angle[0];
- ROTATE0(Ray, i, i*2*M_PI/180);
- ROTATE0(DetS, i, i*2*M_PI/180);
- ROTATE0(DetU, i, i*2*M_PI/180);
- ROTATE0(DetV, i, i*2*M_PI/180);
- }
-#undef ROTATE0
-
- astraCUDA3d::Par3DFP(volData, projData, dims, angle, 1.0f);
-#if 1
- float* bufs = new float[180*512];
-
- for (int i = 0; i < 512; ++i) {
- cudaMemcpy(bufs, ((float*)projData.ptr)+180*512*i, 180*512*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", projData.pitch, projData.xsize, projData.ysize);
-
- char fname[20];
- sprintf(fname, "sino%03d.png", i);
- saveImage(fname, 180, 512, bufs, 0, 512);
- }
-
- float* bufp = new float[512*512];
-
- for (int i = 0; i < 180; ++i) {
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(bufp+512*j, ((float*)projData.ptr)+180*512*j+512*i, 512*sizeof(float), cudaMemcpyDeviceToHost);
- }
-
- char fname[20];
- sprintf(fname, "proj%03d.png", i);
- saveImage(fname, 512, 512, bufp, 0, 512);
- }
-#endif
- for (unsigned int i = 0; i < 256*256; ++i)
- slice[i] = 0.0f;
- for (unsigned int i = 0; i < 256; ++i) {
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
- }
-
- astraCUDA3d::Par3DBP(volData, projData, dims, angle, 1.0f);
-#if 1
- float* buf = new float[256*256];
-
- for (int i = 0; i < 256; ++i) {
- cudaMemcpy(buf, ((float*)volData.ptr)+256*256*i, 256*256*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", volData.pitch, volData.xsize, volData.ysize);
-
- char fname[20];
- sprintf(fname, "vol%03d.png", i);
- saveImage(fname, 256, 256, buf, 0, 60000);
- }
-#endif
-
-}
-#endif
diff --git a/cuda/3d/par3d_fp.cu b/cuda/3d/par3d_fp.cu
index 515b1ba..0a4a5cc 100644
--- a/cuda/3d/par3d_fp.cu
+++ b/cuda/3d/par3d_fp.cu
@@ -28,11 +28,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/3d/util3d.h"
#include "astra/cuda/3d/dims3d.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
-
#include <cstdio>
#include <cassert>
#include <iostream>
@@ -751,166 +746,3 @@ bool Par3DFP_SumSqW(cudaPitchedPtr D_volumeData,
}
-
-#ifdef STANDALONE
-
-using namespace astraCUDA3d;
-
-int main()
-{
- cudaSetDevice(1);
-
-
- SDimensions3D dims;
- dims.iVolX = 500;
- dims.iVolY = 500;
- dims.iVolZ = 81;
- dims.iProjAngles = 241;
- dims.iProjU = 600;
- dims.iProjV = 100;
- dims.iRaysPerDet = 1;
-
- SPar3DProjection base;
- base.fRayX = 1.0f;
- base.fRayY = 0.0f;
- base.fRayZ = 0.1f;
-
- base.fDetSX = 0.0f;
- base.fDetSY = -300.0f;
- base.fDetSZ = -50.0f;
-
- base.fDetUX = 0.0f;
- base.fDetUY = 1.0f;
- base.fDetUZ = 0.0f;
-
- base.fDetVX = 0.0f;
- base.fDetVY = 0.0f;
- base.fDetVZ = 1.0f;
-
- SPar3DProjection angle[dims.iProjAngles];
-
- cudaPitchedPtr volData; // pitch, ptr, xsize, ysize
-
- volData = allocateVolumeData(dims);
-
- cudaPitchedPtr projData; // pitch, ptr, xsize, ysize
-
- projData = allocateProjectionData(dims);
-
- unsigned int ix = 500,iy = 500;
-
- float* buf = new float[dims.iProjU*dims.iProjV];
-
- float* slice = new float[dims.iVolX*dims.iVolY];
- for (int i = 0; i < dims.iVolX*dims.iVolY; ++i)
- slice[i] = 1.0f;
-
- for (unsigned int a = 0; a < 241; a += dims.iProjAngles) {
-
- zeroProjectionData(projData, dims);
-
- for (int y = 0; y < iy; y += dims.iVolY) {
- for (int x = 0; x < ix; x += dims.iVolX) {
-
- timeval st;
- tic(st);
-
- for (int z = 0; z < dims.iVolZ; ++z) {
-// char sfn[256];
-// sprintf(sfn, "/home/wpalenst/projects/cone_simulation/phantom_4096/mouse_fem_phantom_%04d.png", 30+z);
-// float* slice = loadSubImage(sfn, x, y, dims.iVolX, dims.iVolY);
-
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = dims.iVolX*sizeof(float);
- ptr.xsize = dims.iVolX*sizeof(float);
- ptr.ysize = dims.iVolY;
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
-
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, z };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaError err = cudaMemcpy3D(&p);
- assert(!err);
-// delete[] slice;
- }
-
- printf("Load: %f\n", toc(st));
-
-#if 0
-
- cudaPos zp = { 0, 0, 0 };
-
- cudaPitchedPtr t;
- t.ptr = new float[1024*1024];
- t.pitch = 1024*4;
- t.xsize = 1024*4;
- t.ysize = 1024;
-
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = zp;
- p.srcPtr = volData;
- p.extent = extentS;
- p.dstArray = 0;
- p.dstPtr = t;
- p.dstPos = zp;
- p.kind = cudaMemcpyDeviceToHost;
- cudaError err = cudaMemcpy3D(&p);
- assert(!err);
-
- char fn[32];
- sprintf(fn, "t%d%d.png", x / dims.iVolX, y / dims.iVolY);
- saveImage(fn, 1024, 1024, (float*)t.ptr);
- saveImage("s.png", 4096, 4096, slice);
- delete[] (float*)t.ptr;
-#endif
-
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = base.f##name##X * cos(alpha) - base.f##name##Y * sin(alpha); angle[i].f##name##Y = base.f##name##X * sin(alpha) + base.f##name##Y * cos(alpha); angle[i].f##name##Z = base.f##name##Z; } while(0)
-#define SHIFT(name,i,x,y) do { angle[i].f##name##X += x; angle[i].f##name##Y += y; } while(0)
- for (int i = 0; i < dims.iProjAngles; ++i) {
- ROTATE0(Ray, i, (a+i)*.8*M_PI/180);
- ROTATE0(DetS, i, (a+i)*.8*M_PI/180);
- ROTATE0(DetU, i, (a+i)*.8*M_PI/180);
- ROTATE0(DetV, i, (a+i)*.8*M_PI/180);
-
-
-// SHIFT(Src, i, (-x+1536), (-y+1536));
-// SHIFT(DetS, i, (-x+1536), (-y+1536));
- }
-#undef ROTATE0
-#undef SHIFT
- tic(st);
-
- astraCUDA3d::Par3DFP(volData, projData, dims, angle, 1.0f);
-
- printf("FP: %f\n", toc(st));
-
- }
- }
- for (unsigned int aa = 0; aa < dims.iProjAngles; ++aa) {
- for (unsigned int v = 0; v < dims.iProjV; ++v)
- cudaMemcpy(buf+v*dims.iProjU, ((float*)projData.ptr)+(v*dims.iProjAngles+aa)*(projData.pitch/sizeof(float)), dims.iProjU*sizeof(float), cudaMemcpyDeviceToHost);
-
- char fname[32];
- sprintf(fname, "proj%03d.png", a+aa);
- saveImage(fname, dims.iProjV, dims.iProjU, buf, 0.0f, 1000.0f);
- }
- }
-
- delete[] buf;
-
-}
-#endif
diff --git a/cuda/3d/sirt3d.cu b/cuda/3d/sirt3d.cu
index 869b2fd..e68bde8 100644
--- a/cuda/3d/sirt3d.cu
+++ b/cuda/3d/sirt3d.cu
@@ -30,10 +30,6 @@ along with the ASTRA Toolbox. If not, see <http://www.gnu.org/licenses/>.
#include "astra/cuda/3d/arith3d.h"
#include "astra/cuda/3d/cone_fp.h"
-#ifdef STANDALONE
-#include "testutil.h"
-#endif
-
#include <cstdio>
#include <cassert>
@@ -375,160 +371,3 @@ bool doSIRT(cudaPitchedPtr& D_volumeData,
}
-#ifdef STANDALONE
-
-using namespace astraCUDA3d;
-
-int main()
-{
- SDimensions3D dims;
- dims.iVolX = 256;
- dims.iVolY = 256;
- dims.iVolZ = 256;
- dims.iProjAngles = 100;
- dims.iProjU = 512;
- dims.iProjV = 512;
- dims.iRaysPerDet = 1;
-
- SConeProjection angle[100];
- angle[0].fSrcX = -2905.6;
- angle[0].fSrcY = 0;
- angle[0].fSrcZ = 0;
-
- angle[0].fDetSX = 694.4;
- angle[0].fDetSY = -122.4704;
- angle[0].fDetSZ = -122.4704;
-
- angle[0].fDetUX = 0;
- angle[0].fDetUY = .4784;
- //angle[0].fDetUY = .5;
- angle[0].fDetUZ = 0;
-
- angle[0].fDetVX = 0;
- angle[0].fDetVY = 0;
- angle[0].fDetVZ = .4784;
-
-#define ROTATE0(name,i,alpha) do { angle[i].f##name##X = angle[0].f##name##X * cos(alpha) - angle[0].f##name##Y * sin(alpha); angle[i].f##name##Y = angle[0].f##name##X * sin(alpha) + angle[0].f##name##Y * cos(alpha); } while(0)
- for (int i = 1; i < 100; ++i) {
- angle[i] = angle[0];
- ROTATE0(Src, i, i*2*M_PI/100);
- ROTATE0(DetS, i, i*2*M_PI/100);
- ROTATE0(DetU, i, i*2*M_PI/100);
- ROTATE0(DetV, i, i*2*M_PI/100);
- }
-#undef ROTATE0
-
-
- cudaPitchedPtr volData = allocateVolumeData(dims);
- cudaPitchedPtr projData = allocateProjectionData(dims);
- zeroProjectionData(projData, dims);
-
- float* pbuf = new float[100*512*512];
- copyProjectionsFromDevice(pbuf, projData, dims);
- copyProjectionsToDevice(pbuf, projData, dims);
- delete[] pbuf;
-
-#if 0
- float* slice = new float[256*256];
- cudaPitchedPtr ptr;
- ptr.ptr = slice;
- ptr.pitch = 256*sizeof(float);
- ptr.xsize = 256*sizeof(float);
- ptr.ysize = 256;
-
- for (unsigned int i = 0; i < 256; ++i) {
- for (unsigned int y = 0; y < 256; ++y)
- for (unsigned int x = 0; x < 256; ++x)
- slice[y*256+x] = (i-127.5)*(i-127.5)+(y-127.5)*(y-127.5)+(x-127.5)*(x-127.5) < 4900 ? 1.0f : 0.0f;
-
- cudaExtent extentS;
- extentS.width = dims.iVolX*sizeof(float);
- extentS.height = dims.iVolY;
- extentS.depth = 1;
- cudaPos sp = { 0, 0, 0 };
- cudaPos dp = { 0, 0, i };
- cudaMemcpy3DParms p;
- p.srcArray = 0;
- p.srcPos = sp;
- p.srcPtr = ptr;
- p.dstArray = 0;
- p.dstPos = dp;
- p.dstPtr = volData;
- p.extent = extentS;
- p.kind = cudaMemcpyHostToDevice;
- cudaMemcpy3D(&p);
- }
- astraCUDA3d::ConeFP(volData, projData, dims, angle, 1.0f);
-
-#else
-
- for (int i = 0; i < 100; ++i) {
- char fname[32];
- sprintf(fname, "Tiffs/%04d.png", 4*i);
- unsigned int w,h;
- float* bufp = loadImage(fname, w,h);
-
- for (int j = 0; j < 512*512; ++j) {
- float v = bufp[j];
- if (v > 236.0f) v = 236.0f;
- v = logf(236.0f / v);
- bufp[j] = 256*v;
- }
-
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(((float*)projData.ptr)+100*512*j+512*i, bufp+512*j, 512*sizeof(float), cudaMemcpyHostToDevice);
- }
-
- delete[] bufp;
-
- }
-#endif
-
-#if 0
- float* bufs = new float[100*512];
-
- for (int i = 0; i < 512; ++i) {
- cudaMemcpy(bufs, ((float*)projData.ptr)+100*512*i, 100*512*sizeof(float), cudaMemcpyDeviceToHost);
-
- printf("%d %d %d\n", projData.pitch, projData.xsize, projData.ysize);
-
- char fname[20];
- sprintf(fname, "sino%03d.png", i);
- saveImage(fname, 100, 512, bufs);
- }
-
- float* bufp = new float[512*512];
-
- for (int i = 0; i < 100; ++i) {
- for (int j = 0; j < 512; ++j) {
- cudaMemcpy(bufp+512*j, ((float*)projData.ptr)+100*512*j+512*i, 512*sizeof(float), cudaMemcpyDeviceToHost);
- }
-
- char fname[20];
- sprintf(fname, "proj%03d.png", i);
- saveImage(fname, 512, 512, bufp);
- }
-#endif
-
- zeroVolumeData(volData, dims);
-
- cudaPitchedPtr maskData;
- maskData.ptr = 0;
-
- astraCUDA3d::doSIRT(volData, projData, maskData, dims, angle, 50);
-#if 1
- float* buf = new float[256*256];
-
- for (int i = 0; i < 256; ++i) {
- cudaMemcpy(buf, ((float*)volData.ptr)+256*256*i, 256*256*sizeof(float), cudaMemcpyDeviceToHost);
-
- char fname[20];
- sprintf(fname, "vol%03d.png", i);
- saveImage(fname, 256, 256, buf);
- }
-#endif
-
- return 0;
-}
-#endif
-