To read the contents of a JPEG file as DCT coefficients, open the file and do jpeg_read_header() as usual. But instead of calling jpeg_start_decompress() and jpeg_read_scanlines(), call jpeg_read_coefficients(). This will read the entire image into a set of virtual coefficient-block arrays, one array per component. The return value is a pointer to an array of virtual-array descriptors. Each virtual array can be accessed directly using the JPEG memory manager’s access_virt_barray method (see Memory management, below, and also read structure.txt’s discussion of virtual array handling). Or, for simple transcoding to a different JPEG file format, the array list can just be handed directly to jpeg_write_coefficients().
if (cinfo->master->trellis_quant_dc) { for (i = 0; i < dc_trellis_candidates; i++) { accumulated_dc_cost[i] = (float *)malloc(num_blocks * sizeof(float)); dc_cost_backtrack[i] = (int *)malloc(num_blocks * sizeof(int)); dc_candidate[i] = (JCOEF *)malloc(num_blocks * sizeof(JCOEF)); if (!accumulated_dc_cost[i] || !dc_cost_backtrack[i] || !dc_candidate[i]) { ERREXIT(cinfo, JERR_OUT_OF_MEMORY); } } }
norm = 0.0; for (i = 1; i < DCTSIZE2; i++) { norm += qtbl->quantval[i] * qtbl->quantval[i]; } norm /= 63.0;
if (mode == 1) { lambda_base = 1.0; lambda_tbl = lambda_table; for (i = 0; i < DCTSIZE2; i++) lambda_table[i] = 1.0 / (qtbl->quantval[i] * qtbl->quantval[i]); } else lambda_base = 1.0 / norm;
for (bi = 0; bi < num_blocks; bi++) { norm = 0.0; for (i = 1; i < DCTSIZE2; i++) { norm += src[bi][i] * src[bi][i]; } norm /= 63.0; if (cinfo->master->lambda_log_scale2 > 0.0) lambda = pow(2.0, cinfo->master->lambda_log_scale1) * lambda_base / (pow(2.0, cinfo->master->lambda_log_scale2) + norm); else lambda = pow(2.0, cinfo->master->lambda_log_scale1 - 12.0) * lambda_base; lambda_dc = lambda * lambda_tbl[0]; accumulated_zero_dist[Ss-1] = 0.0; accumulated_cost[Ss-1] = 0.0; /* Do DC coefficient */ if (cinfo->master->trellis_quant_dc) { int sign = src[bi][0] >> 31; int x = abs(src[bi][0]); int q = 8 * qtbl->quantval[0]; int qval; float dc_candidate_dist; qval = (x + q/2) / q; /* quantized value (round nearest) */ for (k = 0; k < dc_trellis_candidates; k++) { int delta; int dc_delta; int bits; dc_candidate[k][bi] = qval - dc_trellis_candidates/2 + k; if (dc_candidate[k][bi] >= (1<<MAX_COEF_BITS)) dc_candidate[k][bi] = (1<<MAX_COEF_BITS)-1; if (dc_candidate[k][bi] <= -(1<<MAX_COEF_BITS)) dc_candidate[k][bi] = -(1<<MAX_COEF_BITS)+1; delta = dc_candidate[k][bi] * q - x; dc_candidate_dist = delta * delta * lambda_dc; dc_candidate[k][bi] *= 1 + 2*sign; /* Take into account DC differences */ if (coef_blocks_above && src_above && cinfo->master->trellis_delta_dc_weight > 0.0) { int dc_above_orig; int dc_above_recon; int dc_orig; int dc_recon; float vertical_dist; dc_above_orig = src_above[bi][0]; dc_above_recon = coef_blocks_above[bi][0] * q; dc_orig = src[bi][0]; dc_recon = dc_candidate[k][bi] * q; /* delta is difference of vertical gradients */ delta = (dc_above_orig - dc_orig) - (dc_above_recon - dc_recon); vertical_dist = delta * delta * lambda_dc; dc_candidate_dist += cinfo->master->trellis_delta_dc_weight * (vertical_dist - dc_candidate_dist); } if (bi == 0) { dc_delta = dc_candidate[k][bi] - *last_dc_val; /* Derive number of suffix bits */ bits = 0; dc_delta = abs(dc_delta); while (dc_delta) { dc_delta >>= 1; bits++; } cost = bits + dctbl->ehufsi[bits] + dc_candidate_dist; accumulated_dc_cost[k][0] = cost; dc_cost_backtrack[k][0] = -1; } else { for (l = 0; l < dc_trellis_candidates; l++) { dc_delta = dc_candidate[k][bi] - dc_candidate[l][bi-1]; /* Derive number of suffix bits */ bits = 0; dc_delta = abs(dc_delta); while (dc_delta) { dc_delta >>= 1; bits++; } cost = bits + dctbl->ehufsi[bits] + dc_candidate_dist + accumulated_dc_cost[l][bi-1]; if (l == 0 || cost < accumulated_dc_cost[k][bi]) { accumulated_dc_cost[k][bi] = cost; dc_cost_backtrack[k][bi] = l; } } } } } /* Do AC coefficients */ for (i = Ss; i <= Se; i++) { int z = jpeg_natural_order[i]; int sign = src[bi][z] >> 31; int x = abs(src[bi][z]); int q = 8 * qtbl->quantval[z]; int candidate[16]; int candidate_bits[16]; float candidate_dist[16]; int num_candidates; int qval; accumulated_zero_dist[i] = x * x * lambda * lambda_tbl[z] + accumulated_zero_dist[i-1]; qval = (x + q/2) / q; /* quantized value (round nearest) */ if (qval == 0) { coef_blocks[bi][z] = 0; accumulated_cost[i] = 1e38; /* Shouldn't be needed */ continue; } if (qval >= (1<<MAX_COEF_BITS)) qval = (1<<MAX_COEF_BITS)-1; num_candidates = jpeg_nbits_table[qval]; for (k = 0; k < num_candidates; k++) { int delta; candidate[k] = (k < num_candidates - 1) ? (2 << k) - 1 : qval; delta = candidate[k] * q - x; candidate_bits[k] = k+1; candidate_dist[k] = delta * delta * lambda * lambda_tbl[z]; } accumulated_cost[i] = 1e38; for (j = Ss-1; j < i; j++) { int zz = jpeg_natural_order[j]; if (j != Ss-1 && coef_blocks[bi][zz] == 0) continue; zero_run = i - 1 - j; if ((zero_run >> 4) && actbl->ehufsi[0xf0] == 0) continue; run_bits = (zero_run >> 4) * actbl->ehufsi[0xf0]; zero_run &= 15; for (k = 0; k < num_candidates; k++) { int coef_bits = actbl->ehufsi[16 * zero_run + candidate_bits[k]]; if (coef_bits == 0) continue; rate = coef_bits + candidate_bits[k] + run_bits; cost = rate + candidate_dist[k]; cost += accumulated_zero_dist[i-1] - accumulated_zero_dist[j] + accumulated_cost[j]; if (cost < accumulated_cost[i]) { coef_blocks[bi][z] = (candidate[k] ^ sign) - sign; accumulated_cost[i] = cost; run_start[i] = j; } } } } last_coeff_idx = Ss-1; best_cost = accumulated_zero_dist[Se] + actbl->ehufsi[0]; cost_all_zeros = accumulated_zero_dist[Se]; best_cost_skip = cost_all_zeros; for (i = Ss; i <= Se; i++) { int z = jpeg_natural_order[i]; if (coef_blocks[bi][z] != 0) { float cost = accumulated_cost[i] + accumulated_zero_dist[Se] - accumulated_zero_dist[i]; float cost_wo_eob = cost; if (i < Se) cost += actbl->ehufsi[0]; if (cost < best_cost) { best_cost = cost; last_coeff_idx = i; best_cost_skip = cost_wo_eob; } } } has_eob = (last_coeff_idx < Se) + (last_coeff_idx == Ss-1); /* Zero out coefficients that are part of runs */ i = Se; while (i >= Ss) { while (i > last_coeff_idx) { int z = jpeg_natural_order[i]; coef_blocks[bi][z] = 0; i--; } last_coeff_idx = run_start[i]; i--; } if (cinfo->master->trellis_eob_opt) { accumulated_zero_block_cost[bi+1] = accumulated_zero_block_cost[bi]; accumulated_zero_block_cost[bi+1] += cost_all_zeros; requires_eob[bi+1] = has_eob; best_cost = 1e38; if (has_eob != 2) { for (i = 0; i <= bi; i++) { int zero_block_run; int nbits; float cost; if (requires_eob[i] == 2) continue; cost = best_cost_skip; /* cost of coding a nonzero block */ cost += accumulated_zero_block_cost[bi]; cost -= accumulated_zero_block_cost[i]; cost += accumulated_block_cost[i]; zero_block_run = bi - i + requires_eob[i]; nbits = jpeg_nbits_table[zero_block_run]; cost += actbl->ehufsi[16*nbits] + nbits; if (cost < best_cost) { block_run_start[bi] = i; best_cost = cost; accumulated_block_cost[bi+1] = cost; } } } } }
if (cinfo->master->trellis_eob_opt) { int last_block = num_blocks; best_cost = 1e38; for (i = 0; i <= num_blocks; i++) { int zero_block_run; int nbits; float cost = 0.0; if (requires_eob[i] == 2) continue; cost += accumulated_zero_block_cost[num_blocks]; cost -= accumulated_zero_block_cost[i]; zero_block_run = num_blocks - i + requires_eob[i]; nbits = jpeg_nbits_table[zero_block_run]; cost += actbl->ehufsi[16*nbits] + nbits; if (cost < best_cost) { best_cost = cost; last_block = i; } } last_block--; bi = num_blocks - 1; while (bi >= 0) { while (bi > last_block) { for (j = Ss; j <= Se; j++) { int z = jpeg_natural_order[j]; coef_blocks[bi][z] = 0; } bi--; } last_block = block_run_start[bi]-1; bi--; } free(accumulated_zero_block_cost); free(accumulated_block_cost); free(block_run_start); free(requires_eob); }
if (cinfo->master->trellis_q_opt) { for (bi = 0; bi < num_blocks; bi++) { for (i = 1; i < DCTSIZE2; i++) { norm_src[i] += src[bi][i] * coef_blocks[bi][i]; norm_coef[i] += 8 * coef_blocks[bi][i] * coef_blocks[bi][i]; } } }
if (cinfo->master->trellis_quant_dc) { j = 0; for (i = 1; i < dc_trellis_candidates; i++) { if (accumulated_dc_cost[i][num_blocks-1] < accumulated_dc_cost[j][num_blocks-1]) j = i; } for (bi = num_blocks-1; bi >= 0; bi--) { coef_blocks[bi][0] = dc_candidate[j][bi]; j = dc_cost_backtrack[j][bi]; }
/* Save DC predictor */ *last_dc_val = coef_blocks[num_blocks-1][0]; for (i = 0; i < dc_trellis_candidates; i++) { free(accumulated_dc_cost[i]); free(dc_cost_backtrack[i]); free(dc_candidate[i]); } }