Removed explicit usage of the 'register' keyword.

Signed-off-by: Michele Calgaro <michele.calgaro@yahoo.it>
pull/2/head
Michele Calgaro 4 years ago
parent 83de0e9edd
commit 15e0330f8a
Signed by: MicheleC
GPG Key ID: 2A75B7CA8ADED5CF

@ -68,7 +68,7 @@ void Charcoal::filterImage(void)
// -- Applying Edge effect ----------------------------------------------- // -- Applying Edge effect -----------------------------------------------
register long i=0; long i=0;
int kernelWidth = getOptimalKernelWidth(m_pencil, m_smooth); int kernelWidth = getOptimalKernelWidth(m_pencil, m_smooth);
if((int)m_orgImage.width() < kernelWidth) if((int)m_orgImage.width() < kernelWidth)
@ -222,7 +222,7 @@ int Charcoal::getOptimalKernelWidth(double radius, double sigma)
{ {
double normalize, value; double normalize, value;
long kernelWidth; long kernelWidth;
register long u; long u;
if(radius > 0.0) if(radius > 0.0)
return((int)(2.0*ceil(radius)+1.0)); return((int)(2.0*ceil(radius)+1.0));

@ -38,9 +38,9 @@ integer f_end(alist *a)
static int static int
#ifdef KR_headers #ifdef KR_headers
copy(from, len, to) FILE *from, *to; register long len; copy(from, len, to) FILE *from, *to; long len;
#else #else
copy(FILE *from, register long len, FILE *to) copy(FILE *from, long len, FILE *to)
#endif #endif
{ {
int len1; int len1;

@ -11,13 +11,13 @@
#ifdef KR_headers #ifdef KR_headers
char *f__icvt(value,ndigit,sign, base) longint value; int *ndigit,*sign; char *f__icvt(value,ndigit,sign, base) longint value; int *ndigit,*sign;
register int base; int base;
#else #else
char *f__icvt(longint value, int *ndigit, int *sign, int base) char *f__icvt(longint value, int *ndigit, int *sign, int base)
#endif #endif
{ {
static char buf[MAXINTLENGTH+1]; static char buf[MAXINTLENGTH+1];
register int i; int i;
ulongint uvalue; ulongint uvalue;
if(value > 0) { if(value > 0) {

@ -8,7 +8,7 @@ integer s_cmp(a0, b0, la, lb) char *a0, *b0; ftnlen la, lb;
integer s_cmp(char *a0, char *b0, ftnlen la, ftnlen lb) integer s_cmp(char *a0, char *b0, ftnlen la, ftnlen lb)
#endif #endif
{ {
register unsigned char *a, *aend, *b, *bend; unsigned char *a, *aend, *b, *bend;
a = (unsigned char *)a0; a = (unsigned char *)a0;
b = (unsigned char *)b0; b = (unsigned char *)b0;
aend = a + la; aend = a + la;

@ -9,12 +9,12 @@
/* assign strings: a = b */ /* assign strings: a = b */
#ifdef KR_headers #ifdef KR_headers
VOID s_copy(a, b, la, lb) register char *a, *b; ftnlen la, lb; VOID s_copy(a, b, la, lb) char *a, *b; ftnlen la, lb;
#else #else
void s_copy(register char *a, register char *b, ftnlen la, ftnlen lb) void s_copy(char *a, char *b, ftnlen la, ftnlen lb)
#endif #endif
{ {
register char *aend, *bend; char *aend, *bend;
aend = a + la; aend = a + la;

@ -8,7 +8,7 @@
#endif #endif
#ifdef KR_headers #ifdef KR_headers
void sig_die(s, kill) register char *s; int kill; void sig_die(s, kill) char *s; int kill;
#else #else
#include "stdlib.h" #include "stdlib.h"
#ifdef __cplusplus #ifdef __cplusplus
@ -16,7 +16,7 @@ extern "C" {
#endif #endif
extern void f_exit(void); extern void f_exit(void);
void sig_die(register char *s, int kill) void sig_die(char *s, int kill)
#endif #endif
{ {
/* print error message, then clear buffers */ /* print error message, then clear buffers */

@ -71,8 +71,8 @@ wrt_Z(n,w,minlen,len) Uint *n; int w, minlen; ftnlen len;
wrt_Z(Uint *n, int w, int minlen, ftnlen len) wrt_Z(Uint *n, int w, int minlen, ftnlen len)
#endif #endif
{ {
register char *s, *se; char *s, *se;
register int i, w1; int i, w1;
static int one = 1; static int one = 1;
static char hex[] = "0123456789ABCDEF"; static char hex[] = "0123456789ABCDEF";
s = (char *)n; s = (char *)n;
@ -121,9 +121,9 @@ wrt_Z(Uint *n, int w, int minlen, ftnlen len)
static int static int
#ifdef KR_headers #ifdef KR_headers
wrt_I(n,w,len, base) Uint *n; ftnlen len; register int base; wrt_I(n,w,len, base) Uint *n; ftnlen len; int base;
#else #else
wrt_I(Uint *n, int w, ftnlen len, register int base) wrt_I(Uint *n, int w, ftnlen len, int base)
#endif #endif
{ int ndigit,sign,spare,i; { int ndigit,sign,spare,i;
longint x; longint x;

@ -128,7 +128,7 @@ inline double RefocusMatrix::c_mat_elt (const CMat * const mat, const int col, c
void RefocusMatrix::convolve_mat (CMat * result, const CMat * const mata, const CMat * const matb) void RefocusMatrix::convolve_mat (CMat * result, const CMat * const mata, const CMat * const matb)
{ {
register int xr, yr, xa, ya; int xr, yr, xa, ya;
for (yr = -result->radius; yr <= result->radius; yr++) for (yr = -result->radius; yr <= result->radius; yr++)
{ {
@ -138,7 +138,7 @@ void RefocusMatrix::convolve_mat (CMat * result, const CMat * const mata, const
const int ya_high = TQMIN (mata->radius, yr + matb->radius); const int ya_high = TQMIN (mata->radius, yr + matb->radius);
const int xa_low = TQMAX (-mata->radius, xr - matb->radius); const int xa_low = TQMAX (-mata->radius, xr - matb->radius);
const int xa_high = TQMIN (mata->radius, xr + matb->radius); const int xa_high = TQMIN (mata->radius, xr + matb->radius);
register double val = 0.0; double val = 0.0;
for (ya = ya_low; ya <= ya_high; ya++) for (ya = ya_low; ya <= ya_high; ya++)
{ {
@ -156,7 +156,7 @@ void RefocusMatrix::convolve_mat (CMat * result, const CMat * const mata, const
void RefocusMatrix::convolve_star_mat (CMat * result, const CMat * const mata, const CMat * const matb) void RefocusMatrix::convolve_star_mat (CMat * result, const CMat * const mata, const CMat * const matb)
{ {
register int xr, yr, xa, ya; int xr, yr, xa, ya;
for (yr = -result->radius; yr <= result->radius; yr++) for (yr = -result->radius; yr <= result->radius; yr++)
{ {
@ -166,7 +166,7 @@ void RefocusMatrix::convolve_star_mat (CMat * result, const CMat * const mata, c
const int ya_high = TQMIN (mata->radius, matb->radius - yr); const int ya_high = TQMIN (mata->radius, matb->radius - yr);
const int xa_low = TQMAX (-mata->radius, -matb->radius - xr); const int xa_low = TQMAX (-mata->radius, -matb->radius - xr);
const int xa_high = TQMIN (mata->radius, matb->radius - xr); const int xa_high = TQMIN (mata->radius, matb->radius - xr);
register double val = 0.0; double val = 0.0;
for (ya = ya_low; ya <= ya_high; ya++) for (ya = ya_low; ya <= ya_high; ya++)
{ {
@ -184,13 +184,13 @@ void RefocusMatrix::convolve_star_mat (CMat * result, const CMat * const mata, c
void RefocusMatrix::convolve_mat_fun (CMat * result, const CMat * const mata, double (f) (int, int)) void RefocusMatrix::convolve_mat_fun (CMat * result, const CMat * const mata, double (f) (int, int))
{ {
register int xr, yr, xa, ya; int xr, yr, xa, ya;
for (yr = -result->radius; yr <= result->radius; yr++) for (yr = -result->radius; yr <= result->radius; yr++)
{ {
for (xr = -result->radius; xr <= result->radius; xr++) for (xr = -result->radius; xr <= result->radius; xr++)
{ {
register double val = 0.0; double val = 0.0;
for (ya = -mata->radius; ya <= mata->radius; ya++) for (ya = -mata->radius; ya <= mata->radius; ya++)
{ {
@ -219,7 +219,7 @@ int RefocusMatrix::as_cidx (const int k, const int l)
void RefocusMatrix::print_c_mat (const CMat * const mat) void RefocusMatrix::print_c_mat (const CMat * const mat)
{ {
register int x, y; int x, y;
for (y = -mat->radius; y <= mat->radius; y++) for (y = -mat->radius; y <= mat->radius; y++)
{ {
@ -255,7 +255,7 @@ Mat *RefocusMatrix::make_s_matrix (CMat * mat, int m, double noise_factor)
{ {
const int mat_size = SQR (2 * m + 1); const int mat_size = SQR (2 * m + 1);
Mat *result = allocate_matrix (mat_size, mat_size); Mat *result = allocate_matrix (mat_size, mat_size);
register int yr, yc, xr, xc; int yr, yc, xr, xc;
for (yr = -m; yr <= m; yr++) for (yr = -m; yr <= m; yr++)
{ {
@ -285,7 +285,7 @@ Mat *RefocusMatrix::make_s_cmatrix (CMat * mat, int m, double noise_factor)
{ {
const int mat_size = as_cidx (m + 1, 0); const int mat_size = as_cidx (m + 1, 0);
Mat *result = allocate_matrix (mat_size, mat_size); Mat *result = allocate_matrix (mat_size, mat_size);
register int yr, yc, xr, xc; int yr, yc, xr, xc;
for (yr = 0; yr <= m; yr++) for (yr = 0; yr <= m; yr++)
{ {
@ -318,7 +318,7 @@ double RefocusMatrix::correlation (const int x, const int y, const double gamma,
Mat *RefocusMatrix::copy_vec (const CMat * const mat, const int m) Mat *RefocusMatrix::copy_vec (const CMat * const mat, const int m)
{ {
Mat *result = allocate_matrix (SQR (2 * m + 1), 1); Mat *result = allocate_matrix (SQR (2 * m + 1), 1);
register int x, y, index = 0; int x, y, index = 0;
for (y = -m; y <= m; y++) for (y = -m; y <= m; y++)
{ {
@ -336,7 +336,7 @@ Mat *RefocusMatrix::copy_vec (const CMat * const mat, const int m)
Mat *RefocusMatrix::copy_cvec (const CMat * const mat, const int m) Mat *RefocusMatrix::copy_cvec (const CMat * const mat, const int m)
{ {
Mat *result = allocate_matrix (as_cidx (m + 1, 0), 1); Mat *result = allocate_matrix (as_cidx (m + 1, 0), 1);
register int x, y, index = 0; int x, y, index = 0;
for (y = 0; y <= m; y++) for (y = 0; y <= m; y++)
{ {
@ -354,7 +354,7 @@ Mat *RefocusMatrix::copy_cvec (const CMat * const mat, const int m)
CMat *RefocusMatrix::copy_cvec2mat (const Mat * const cvec, const int m) CMat *RefocusMatrix::copy_cvec2mat (const Mat * const cvec, const int m)
{ {
CMat *result = allocate_c_mat (m); CMat *result = allocate_c_mat (m);
register int x, y; int x, y;
for (y = -m; y <= m; y++) for (y = -m; y <= m; y++)
{ {
@ -370,7 +370,7 @@ CMat *RefocusMatrix::copy_cvec2mat (const Mat * const cvec, const int m)
CMat *RefocusMatrix::copy_vec2mat (const Mat * const cvec, const int m) CMat *RefocusMatrix::copy_vec2mat (const Mat * const cvec, const int m)
{ {
CMat *result = allocate_c_mat (m); CMat *result = allocate_c_mat (m);
register int x, y; int x, y;
for (y = -m; y <= m; y++) for (y = -m; y <= m; y++)
{ {
@ -482,7 +482,7 @@ void RefocusMatrix::fill_matrix (CMat * matrix, const int m,
double f (const int, const int, const double), double f (const int, const int, const double),
const double fun_arg) const double fun_arg)
{ {
register int x, y; int x, y;
init_c_mat (matrix, m); init_c_mat (matrix, m);
for (y = -m; y <= m; y++) for (y = -m; y <= m; y++)
@ -498,7 +498,7 @@ void RefocusMatrix::fill_matrix2 (CMat * matrix, const int m,
double f (const int, const int, const double, const double), double f (const int, const int, const double, const double),
const double fun_arg1, const double fun_arg2) const double fun_arg1, const double fun_arg2)
{ {
register int x, y; int x, y;
init_c_mat (matrix, m); init_c_mat (matrix, m);
for (y = -m; y <= m; y++) for (y = -m; y <= m; y++)
@ -512,7 +512,7 @@ void RefocusMatrix::fill_matrix2 (CMat * matrix, const int m,
void RefocusMatrix::make_gaussian_convolution (const double gradius, CMat * convolution, const int m) void RefocusMatrix::make_gaussian_convolution (const double gradius, CMat * convolution, const int m)
{ {
register int x, y; int x, y;
#ifdef RF_DEBUG #ifdef RF_DEBUG
DDebug() << "gauss: " << gradius << endl; DDebug() << "gauss: " << gradius << endl;
@ -589,9 +589,9 @@ double RefocusMatrix::circle_intensity (const int x, const int y, const double r
} }
else else
{ {
register double xlo = TQABS (x) - 0.5, xhi = TQABS (x) + 0.5, double xlo = TQABS (x) - 0.5, xhi = TQABS (x) + 0.5,
ylo = TQABS (y) - 0.5, yhi = TQABS (y) + 0.5; ylo = TQABS (y) - 0.5, yhi = TQABS (y) + 0.5;
register double symmetry_factor = 1, xc1, xc2; double symmetry_factor = 1, xc1, xc2;
if (xlo < 0) if (xlo < 0)
{ {

@ -55,7 +55,7 @@ FreeRotation::FreeRotation(Digikam::DImg *orgImage, TQObject *parent, double ang
void FreeRotation::filterImage(void) void FreeRotation::filterImage(void)
{ {
int progress; int progress;
register int w, h, nw, nh, j, i = 0; int w, h, nw, nh, j, i = 0;
int nNewHeight, nNewWidth; int nNewHeight, nNewWidth;
int nhdx, nhdy, nhsx, nhsy; int nhdx, nhdy, nhsx, nhsy;
double lfSin, lfCos, lfx, lfy; double lfSin, lfCos, lfx, lfy;

@ -207,7 +207,7 @@ bool RainDrop::CreateRainDrop(uchar *pBits, int Width, int Height, bool sixteenB
uchar *pResBits, uchar* pStatusBits, uchar *pResBits, uchar* pStatusBits,
int X, int Y, int DropSize, double Coeff, bool bLimitRange) int X, int Y, int DropSize, double Coeff, bool bLimitRange)
{ {
register int w, h, nw1, nh1, nw2, nh2; int w, h, nw1, nh1, nw2, nh2;
int nHalfSize = DropSize / 2; int nHalfSize = DropSize / 2;
int nBright; int nBright;
double lfRadius, lfOldRadius, lfAngle, lfDiv; double lfRadius, lfOldRadius, lfAngle, lfDiv;
@ -403,7 +403,7 @@ bool RainDrop::CreateRainDrop(uchar *pBits, int Width, int Height, bool sixteenB
bool RainDrop::CanBeDropped(int Width, int Height, uchar *pStatusBits, int X, int Y, bool RainDrop::CanBeDropped(int Width, int Height, uchar *pStatusBits, int X, int Y,
int DropSize, bool bLimitRange) int DropSize, bool bLimitRange)
{ {
register int w, h, i = 0; int w, h, i = 0;
int nHalfSize = DropSize / 2; int nHalfSize = DropSize / 2;
if (pStatusBits == NULL) if (pStatusBits == NULL)
@ -433,7 +433,7 @@ bool RainDrop::CanBeDropped(int Width, int Height, uchar *pStatusBits, int X, in
bool RainDrop::SetDropStatusBits (int Width, int Height, uchar *pStatusBits, bool RainDrop::SetDropStatusBits (int Width, int Height, uchar *pStatusBits,
int X, int Y, int DropSize) int X, int Y, int DropSize)
{ {
register int w, h, i = 0; int w, h, i = 0;
int nHalfSize = DropSize / 2; int nHalfSize = DropSize / 2;
if (pStatusBits == NULL) if (pStatusBits == NULL)

@ -58,7 +58,7 @@ Shear::Shear(Digikam::DImg *orgImage, TQObject *parent, float hAngle, float vAng
void Shear::filterImage(void) void Shear::filterImage(void)
{ {
int progress; int progress;
register int x, y, p = 0, pt; int x, y, p = 0, pt;
int new_width, new_height; int new_width, new_height;
double nx, ny, dx, dy; double nx, ny, dx, dy;
double horz_factor, vert_factor; double horz_factor, vert_factor;

@ -84,7 +84,7 @@ void DImgGaussianBlur::gaussianBlurImage(uchar *data, int width, int height, boo
int nKSize, nCenter; int nKSize, nCenter;
double x, sd, factor, lnsd, lnfactor; double x, sd, factor, lnsd, lnfactor;
register int i, j, n, h, w; int i, j, n, h, w;
nKSize = 2 * radius + 1; nKSize = 2 * radius + 1;
nCenter = nKSize / 2; nCenter = nKSize / 2;

@ -68,7 +68,7 @@ void DImgImageFilters::equalizeImage(uchar *data, int w, int h, bool sixteenBit)
struct double_packet high, low, intensity; struct double_packet high, low, intensity;
struct double_packet *map; struct double_packet *map;
struct int_packet *equalize_map; struct int_packet *equalize_map;
register long i; long i;
// Create an histogram of the current image. // Create an histogram of the current image.
ImageHistogram *histogram = new ImageHistogram(data, w, h, sixteenBit); ImageHistogram *histogram = new ImageHistogram(data, w, h, sixteenBit);
@ -217,7 +217,7 @@ void DImgImageFilters::stretchContrastImage(uchar *data, int w, int h, bool sixt
struct double_packet high, low, intensity; struct double_packet high, low, intensity;
struct int_packet *normalize_map; struct int_packet *normalize_map;
long long number_pixels; long long number_pixels;
register long i; long i;
unsigned long threshold_intensity; unsigned long threshold_intensity;
// Create an histogram of the current image. // Create an histogram of the current image.
@ -717,7 +717,7 @@ void DImgImageFilters::channelMixerImage(uchar *data, int Width, int Height, boo
return; return;
} }
register int i; int i;
double rnorm = CalculateNorm (rrGain, rgGain, rbGain, bPreserveLum); double rnorm = CalculateNorm (rrGain, rgGain, rbGain, bPreserveLum);
double gnorm = CalculateNorm (grGain, ggGain, gbGain, bPreserveLum); double gnorm = CalculateNorm (grGain, ggGain, gbGain, bPreserveLum);

@ -89,7 +89,7 @@ void DImgSharpen::sharpenImage(double radius, double sigma)
} }
double alpha, normalize=0.0; double alpha, normalize=0.0;
register long i=0, u, v; long i=0, u, v;
int kernelWidth = getOptimalKernelWidth(radius, sigma); int kernelWidth = getOptimalKernelWidth(radius, sigma);
@ -216,7 +216,7 @@ int DImgSharpen::getOptimalKernelWidth(double radius, double sigma)
{ {
double normalize, value; double normalize, value;
long kernelWidth; long kernelWidth;
register long u; long u;
if(radius > 0.0) if(radius > 0.0)
return((int)(2.0*ceil(radius)+1.0)); return((int)(2.0*ceil(radius)+1.0));

@ -100,7 +100,7 @@ bool JP2KLoader::load(const TQString& filePath, DImgLoaderObserver *observer)
// ------------------------------------------------------------------- // -------------------------------------------------------------------
// Initialize JPEG 2000 API. // Initialize JPEG 2000 API.
register long i, x, y; long i, x, y;
int components[4]; int components[4];
unsigned int maximum_component_depth, scale[4], x_step[4], y_step[4]; unsigned int maximum_component_depth, scale[4], x_step[4], y_step[4];
unsigned long number_components; unsigned long number_components;
@ -468,7 +468,7 @@ bool JP2KLoader::save(const TQString& filePath, DImgLoaderObserver *observer)
// ------------------------------------------------------------------- // -------------------------------------------------------------------
// Initialize JPEG 2000 API. // Initialize JPEG 2000 API.
register long i, x, y; long i, x, y;
unsigned long number_components; unsigned long number_components;
jas_image_t *jp2_image = 0; jas_image_t *jp2_image = 0;

@ -830,7 +830,7 @@ void PNGLoader::writeRawProfile(png_struct *ping, png_info *ping_info, char *pro
{ {
png_textp text; png_textp text;
register long i; long i;
uchar *sp; uchar *sp;
@ -890,11 +890,11 @@ void PNGLoader::writeRawProfile(png_struct *ping, png_info *ping_info, char *pro
size_t PNGLoader::concatenateString(char *destination, const char *source, const size_t length) size_t PNGLoader::concatenateString(char *destination, const char *source, const size_t length)
{ {
register char *q; char *q;
register const char *p; const char *p;
register size_t i; size_t i;
size_t count; size_t count;
@ -931,11 +931,11 @@ size_t PNGLoader::concatenateString(char *destination, const char *source, const
size_t PNGLoader::copyString(char *destination, const char *source, const size_t length) size_t PNGLoader::copyString(char *destination, const char *source, const size_t length)
{ {
register char *q; char *q;
register const char *p; const char *p;
register size_t i; size_t i;
if ( !destination || !source || length == 0 ) if ( !destination || !source || length == 0 )
return 0; return 0;

@ -172,7 +172,7 @@ void GreycstorationIface::stopComputation()
void GreycstorationIface::filterImage() void GreycstorationIface::filterImage()
{ {
register int x, y; int x, y;
DDebug() << "GreycstorationIface::Initialization..." << endl; DDebug() << "GreycstorationIface::Initialization..." << endl;
@ -330,7 +330,7 @@ void GreycstorationIface::inpainting()
{ {
// Copy the inpainting image data into a CImg type image with three channels and no alpha. // Copy the inpainting image data into a CImg type image with three channels and no alpha.
register int x, y; int x, y;
d->mask = CImg<uchar>(d->inPaintingMask.width(), d->inPaintingMask.height(), 1, 3); d->mask = CImg<uchar>(d->inPaintingMask.width(), d->inPaintingMask.height(), 1, 3);
uchar *ptr = d->inPaintingMask.bits(); uchar *ptr = d->inPaintingMask.bits();

@ -167,7 +167,7 @@ void ImageHistogram::run()
void ImageHistogram::calcHistogramValues() void ImageHistogram::calcHistogramValues()
{ {
register uint i; uint i;
int max; int max;
if (d->parent) if (d->parent)

@ -54,7 +54,7 @@ void ClampRGB(LPVEC3 RGB)
static static
int RegressionSamplerA2B(register WORD In[], register WORD Out[], register LPVOID Cargo) int RegressionSamplerA2B(WORD In[], WORD Out[], LPVOID Cargo)
{ {
cmsCIEXYZ xyz; cmsCIEXYZ xyz;
cmsCIELab Lab; cmsCIELab Lab;
@ -95,7 +95,7 @@ int RegressionSamplerA2B(register WORD In[], register WORD Out[], register LPVOI
static static
int RegressionSamplerB2A(register WORD In[], register WORD Out[], register LPVOID Cargo) int RegressionSamplerB2A(WORD In[], WORD Out[], LPVOID Cargo)
{ {
cmsCIELab Lab; cmsCIELab Lab;
cmsCIEXYZ xyz; cmsCIEXYZ xyz;

@ -139,7 +139,7 @@ BOOL cmsxScannerProfilerInit(LPSCANNERPROFILERDATA sys)
/* Auxiliar: take RGB and update gauge */ /* Auxiliar: take RGB and update gauge */
static static
void GetRGB(LPPROFILERCOMMONDATA hdr, register WORD In[], double* r, double* g, double* b) void GetRGB(LPPROFILERCOMMONDATA hdr, WORD In[], double* r, double* g, double* b)
{ {
static int Count = 0, n_old = 0; static int Count = 0, n_old = 0;
double R, G, B; double R, G, B;
@ -172,7 +172,7 @@ void GetRGB(LPPROFILERCOMMONDATA hdr, register WORD In[], double* r, double* g,
/* The sampler for Lab */ /* The sampler for Lab */
static static
int RegressionSamplerLab(register WORD In[], register WORD Out[], register LPVOID Cargo) int RegressionSamplerLab(WORD In[], WORD Out[], LPVOID Cargo)
{ {
cmsCIEXYZ xyz; cmsCIEXYZ xyz;
cmsCIELab Lab; cmsCIELab Lab;
@ -235,7 +235,7 @@ int RegressionSamplerLab(register WORD In[], register WORD Out[], register LPVOI
/* The sampler for XYZ */ /* The sampler for XYZ */
static static
int RegressionSamplerXYZ(register WORD In[], register WORD Out[], register LPVOID Cargo) int RegressionSamplerXYZ(WORD In[], WORD Out[], LPVOID Cargo)
{ {
cmsCIEXYZ xyz; cmsCIEXYZ xyz;
double r, g, b; double r, g, b;

@ -470,8 +470,8 @@ void ReadReal(LPIT8 it8, int inum)
static static
void InSymbol(LPIT8 it8) void InSymbol(LPIT8 it8)
{ {
register char *idptr; char *idptr;
register int k; int k;
SYMBOL key; SYMBOL key;
int sng; int sng;

@ -361,8 +361,8 @@ static int vxprintf(
} }
bufpt = &buf[etBUFSIZE-1]; bufpt = &buf[etBUFSIZE-1];
{ {
register char *cset; /* Use registers for speed */ char *cset; /* Use registers for speed */
register int base; int base;
cset = infop->charset; cset = infop->charset;
base = infop->base; base = infop->base;
do{ /* Convert to ascii */ do{ /* Convert to ascii */
@ -603,7 +603,7 @@ static int vxprintf(
** the output. ** the output.
*/ */
if( !flag_leftjustify ){ if( !flag_leftjustify ){
register int nspace; int nspace;
nspace = width-length; nspace = width-length;
if( nspace>0 ){ if( nspace>0 ){
count += nspace; count += nspace;
@ -619,7 +619,7 @@ static int vxprintf(
count += length; count += length;
} }
if( flag_leftjustify ){ if( flag_leftjustify ){
register int nspace; int nspace;
nspace = width-length; nspace = width-length;
if( nspace>0 ){ if( nspace>0 ){
count += nspace; count += nspace;

@ -499,14 +499,14 @@ int sqliteHashNoCase(const char *z, int n){
** there is no consistency, we will define our own. ** there is no consistency, we will define our own.
*/ */
int sqliteStrICmp(const char *zLeft, const char *zRight){ int sqliteStrICmp(const char *zLeft, const char *zRight){
register unsigned char *a, *b; unsigned char *a, *b;
a = (unsigned char *)zLeft; a = (unsigned char *)zLeft;
b = (unsigned char *)zRight; b = (unsigned char *)zRight;
while( *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; } while( *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; }
return UpperToLower[*a] - UpperToLower[*b]; return UpperToLower[*a] - UpperToLower[*b];
} }
int sqliteStrNICmp(const char *zLeft, const char *zRight, int N){ int sqliteStrNICmp(const char *zLeft, const char *zRight, int N){
register unsigned char *a, *b; unsigned char *a, *b;
a = (unsigned char *)zLeft; a = (unsigned char *)zLeft;
b = (unsigned char *)zRight; b = (unsigned char *)zRight;
while( N-- > 0 && *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; } while( N-- > 0 && *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; }
@ -940,7 +940,7 @@ static int sqlite_utf8_to_int(const unsigned char *z){
*/ */
int int
sqliteGlobCompare(const unsigned char *zPattern, const unsigned char *zString){ sqliteGlobCompare(const unsigned char *zPattern, const unsigned char *zString){
register int c; int c;
int invert; int invert;
int seen; int seen;
int c2; int c2;
@ -1029,7 +1029,7 @@ sqliteGlobCompare(const unsigned char *zPattern, const unsigned char *zString){
*/ */
int int
sqliteLikeCompare(const unsigned char *zPattern, const unsigned char *zString){ sqliteLikeCompare(const unsigned char *zPattern, const unsigned char *zString){
register int c; int c;
int c2; int c2;
while( (c = UpperToLower[*zPattern])!=0 ){ while( (c = UpperToLower[*zPattern])!=0 ){

@ -14414,8 +14414,8 @@ static void vxprintf(
bufpt -= 2; bufpt -= 2;
} }
{ {
register const char *cset; /* Use registers for speed */ const char *cset; /* Use registers for speed */
register int base; int base;
cset = &aDigits[infop->charset]; cset = &aDigits[infop->charset];
base = infop->base; base = infop->base;
do{ /* Convert to ascii */ do{ /* Convert to ascii */
@ -14684,7 +14684,7 @@ static void vxprintf(
** the output. ** the output.
*/ */
if( !flag_leftjustify ){ if( !flag_leftjustify ){
register int nspace; int nspace;
nspace = width-length; nspace = width-length;
if( nspace>0 ){ if( nspace>0 ){
appendSpace(pAccum, nspace); appendSpace(pAccum, nspace);
@ -14694,7 +14694,7 @@ static void vxprintf(
sqlite3StrAccumAppend(pAccum, bufpt, length); sqlite3StrAccumAppend(pAccum, bufpt, length);
} }
if( flag_leftjustify ){ if( flag_leftjustify ){
register int nspace; int nspace;
nspace = width-length; nspace = width-length;
if( nspace>0 ){ if( nspace>0 ){
appendSpace(pAccum, nspace); appendSpace(pAccum, nspace);
@ -16201,14 +16201,14 @@ SQLITE_PRIVATE const unsigned char sqlite3UpperToLower[] = {
** there is no consistency, we will define our own. ** there is no consistency, we will define our own.
*/ */
SQLITE_PRIVATE int sqlite3StrICmp(const char *zLeft, const char *zRight){ SQLITE_PRIVATE int sqlite3StrICmp(const char *zLeft, const char *zRight){
register unsigned char *a, *b; unsigned char *a, *b;
a = (unsigned char *)zLeft; a = (unsigned char *)zLeft;
b = (unsigned char *)zRight; b = (unsigned char *)zRight;
while( *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; } while( *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; }
return UpperToLower[*a] - UpperToLower[*b]; return UpperToLower[*a] - UpperToLower[*b];
} }
SQLITE_PRIVATE int sqlite3StrNICmp(const char *zLeft, const char *zRight, int N){ SQLITE_PRIVATE int sqlite3StrNICmp(const char *zLeft, const char *zRight, int N){
register unsigned char *a, *b; unsigned char *a, *b;
a = (unsigned char *)zLeft; a = (unsigned char *)zLeft;
b = (unsigned char *)zRight; b = (unsigned char *)zRight;
while( N-- > 0 && *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; } while( N-- > 0 && *a!=0 && UpperToLower[*a]==UpperToLower[*b]){ a++; b++; }
@ -42104,7 +42104,7 @@ static void updateMaxBlobsize(Mem *p){
#define Release(P) if((P)->flags&MEM_Dyn){ sqlite3VdbeMemRelease(P); } #define Release(P) if((P)->flags&MEM_Dyn){ sqlite3VdbeMemRelease(P); }
/* /*
** Convert the given register into a string if it isn't one ** Convert the given into a string if it isn't one
** already. Return non-zero if a malloc() fails. ** already. Return non-zero if a malloc() fails.
*/ */
#define Stringify(P, enc) \ #define Stringify(P, enc) \

@ -207,7 +207,7 @@ void Texture::doHgradient()
xb = (float) d->color0.blue(); xb = (float) d->color0.blue();
unsigned char *pr = d->red, *pg = d->green, *pb = d->blue; unsigned char *pr = d->red, *pg = d->green, *pb = d->blue;
register int x, y; int x, y;
drx = (float) (d->color1.red() - d->color0.red()); drx = (float) (d->color1.red() - d->color0.red());
dgx = (float) (d->color1.green() - d->color0.green()); dgx = (float) (d->color1.green() - d->color0.green());
@ -252,7 +252,7 @@ void Texture::doVgradient()
dby /= d->height; dby /= d->height;
unsigned char *pr = d->red, *pg = d->green, *pb = d->blue; unsigned char *pr = d->red, *pg = d->green, *pb = d->blue;
register int y; int y;
for (y = 0; y < d->height; y++, pr += d->width, pg += d->width, pb += d->width) { for (y = 0; y < d->height; y++, pr += d->width, pg += d->width, pb += d->width) {
memset(pr, (unsigned char) yr, d->width); memset(pr, (unsigned char) yr, d->width);
@ -279,7 +279,7 @@ void Texture::doDgradient()
unsigned int *xt = xtable; unsigned int *xt = xtable;
unsigned int *yt = ytable; unsigned int *yt = ytable;
register int x, y; int x, y;
dry = drx = (float) (d->color1.red() - d->color0.red()); dry = drx = (float) (d->color1.red() - d->color0.red());
dgy = dgx = (float) (d->color1.green() - d->color0.green()); dgy = dgx = (float) (d->color1.green() - d->color0.green());
@ -337,8 +337,8 @@ void Texture::doBevel()
{ {
unsigned char *pr = d->red, *pg = d->green, *pb = d->blue; unsigned char *pr = d->red, *pg = d->green, *pb = d->blue;
register unsigned char r, g, b, rr ,gg ,bb; unsigned char r, g, b, rr ,gg ,bb;
register unsigned int w = d->width, h = d->height - 1, wh = w * h; unsigned int w = d->width, h = d->height - 1, wh = w * h;
while (--w) while (--w)
{ {
@ -479,7 +479,7 @@ void Texture::buildImage()
unsigned int* bits = (unsigned int*) image.bits(); unsigned int* bits = (unsigned int*) image.bits();
register int p; int p;
for (p =0; p < d->width*d->height; p++) for (p =0; p < d->width*d->height; p++)
{ {
*bits = 0xff << 24 | *pr << 16 | *pg << 8 | *pb; *bits = 0xff << 24 | *pr << 16 | *pg << 8 | *pb;

Loading…
Cancel
Save